CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
Functions | Variables
MuScleFitUtils.cc File Reference
#include "MuonAnalysis/MomentumScaleCalibration/interface/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 64 of file MuScleFitUtils.cc.

References funct::exp().

Referenced by MuScleFitUtils::fitReso().

64  {
65  return par[0]*exp(-0.5*((x[0]-par[1])/par[2])*((x[0]-par[1])/par[2]));
66 }
Exp< T >::type exp(const T &t)
Definition: Exp.h:22
Definition: DDAxes.h:10
const double par[8 *NPar][4]
void likelihood ( int &  npar,
double *  grad,
double &  fval,
double *  xval,
int  flag 
)

Definition at line 1648 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_, funct::log(), MuScleFitUtils::loopCounter, MuScleFitUtils::massProb(), MuScleFitUtils::massResolution(), MuScleFitUtils::minuitLoop_, MuScleFitUtils::normalizationChanged_, MuScleFitUtils::normalizeLikelihoodByEventNumber_, MuScleFitUtils::oldNormalization_, MuScleFitUtils::ReducedSavedPair, MuScleFitUtils::rminPtr_, MuScleFitUtils::SavedPair, and CommonMethods::weight().

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

1648  {
1649 
1650  if (MuScleFitUtils::debug>19) std::cout << "[MuScleFitUtils-likelihood]: In likelihood function" << std::endl;
1651 
1652  const lorentzVector * recMu1;
1653  const lorentzVector * recMu2;
1654  lorentzVector corrMu1;
1655  lorentzVector corrMu2;
1656 
1657  // if (MuScleFitUtils::debug>19) {
1658  // int parnumber = (int)(MuScleFitUtils::parResol.size()+MuScleFitUtils::parScale.size()+
1659  // MuScleFitUtils::parCrossSection.size()+MuScleFitUtils::parBgr.size());
1660  // std::cout << "[MuScleFitUtils-likelihood]: Looping on tree with ";
1661  // for (int ipar=0; ipar<parnumber; ipar++) {
1662  // std::cout << "Parameter #" << ipar << " with value " << xval[ipar] << " ";
1663  // }
1664  // std::cout << std::endl;
1665  // }
1666 
1667  // Loop on the tree
1668  // ----------------
1669  double flike = 0;
1670  int evtsinlik = 0;
1671  int evtsoutlik = 0;
1672  // std::cout << "SavedPair.size() = " << MuScleFitUtils::SavedPair.size() << std::endl;
1673  if( MuScleFitUtils::debug>0 ) {
1674  std::cout << "SavedPair.size() = " << MuScleFitUtils::SavedPair.size() << std::endl;
1675  std::cout << "ReducedSavedPair.size() = " << MuScleFitUtils::ReducedSavedPair.size() << std::endl;
1676  }
1677  // for( unsigned int nev=0; nev<MuScleFitUtils::SavedPair.size(); ++nev ) {
1678  for( unsigned int nev=0; nev<MuScleFitUtils::ReducedSavedPair.size(); ++nev ) {
1679 
1680  // recMu1 = &(MuScleFitUtils::SavedPair[nev].first);
1681  // recMu2 = &(MuScleFitUtils::SavedPair[nev].second);
1682  recMu1 = &(MuScleFitUtils::ReducedSavedPair[nev].first);
1683  recMu2 = &(MuScleFitUtils::ReducedSavedPair[nev].second);
1684 
1685  // Compute original mass
1686  // ---------------------
1687  double mass = MuScleFitUtils::invDimuonMass( *recMu1, *recMu2 );
1688 
1689  // Compute weight and reference mass (from original mass)
1690  // ------------------------------------------------------
1692  if( weight!=0. ) {
1693  // Compute corrected mass (from previous biases) only if we are currently fitting the scale
1694  // ----------------------------------------------------------------------------------------
1696 // std::cout << "Original pt1 = " << corrMu1.Pt() << std::endl;
1697 // std::cout << "Original pt2 = " << corrMu2.Pt() << std::endl;
1698  corrMu1 = MuScleFitUtils::applyScale(*recMu1, xval, -1);
1699  corrMu2 = MuScleFitUtils::applyScale(*recMu2, xval, 1);
1700 
1701 // if( (corrMu1.Pt() != corrMu1.Pt()) || (corrMu2.Pt() != corrMu2.Pt()) ) {
1702 // std::cout << "Rescaled pt1 = " << corrMu1.Pt() << std::endl;
1703 // std::cout << "Rescaled pt2 = " << corrMu2.Pt() << std::endl;
1704 // }
1705 // std::cout << "Rescaled pt1 = " << corrMu1.Pt() << std::endl;
1706 // std::cout << "Rescaled pt2 = " << corrMu2.Pt() << std::endl;
1707  }
1708  else {
1709  corrMu1 = *recMu1;
1710  corrMu2 = *recMu2;
1711 
1712 // if( (corrMu1.Pt() != corrMu1.Pt()) || (corrMu2.Pt() != corrMu2.Pt()) ) {
1713 // std::cout << "Not rescaled pt1 = " << corrMu1.Pt() << std::endl;
1714 // std::cout << "Not rescaled pt2 = " << corrMu2.Pt() << std::endl;
1715 // }
1716  }
1717  double corrMass = MuScleFitUtils::invDimuonMass(corrMu1, corrMu2);
1718  double Y = (corrMu1+corrMu2).Rapidity();
1719  double resEta = (corrMu1+corrMu2).Eta();
1720  if( MuScleFitUtils::debug>19 ) {
1721  std::cout << "[MuScleFitUtils-likelihood]: Original/Corrected resonance mass = " << mass
1722  << " / " << corrMass << std::endl;
1723  }
1724 
1725  // Compute mass resolution
1726  // -----------------------
1727  double massResol = MuScleFitUtils::massResolution(corrMu1, corrMu2, xval);
1728  if (MuScleFitUtils::debug>19)
1729  std::cout << "[MuScleFitUtils-likelihood]: Resolution is " << massResol << std::endl;
1730 
1731  // Compute probability of this mass value including background modeling
1732  // --------------------------------------------------------------------
1733  if (MuScleFitUtils::debug>1) std::cout << "calling massProb inside likelihood function" << std::endl;
1734 
1735  double prob = MuScleFitUtils::massProb( corrMass, resEta, Y, massResol, xval );
1736  if (MuScleFitUtils::debug>1) std::cout << "likelihood:massProb = " << prob << std::endl;
1737 
1738  // Compute likelihood
1739  // ------------------
1740  if( prob>0 ) {
1741  // flike += log(prob*10000)*weight; // NNBB! x10000 to see if we can recover the problem of boundary
1742  flike += log(prob)*weight;
1743  evtsinlik += 1; // NNBB test: see if likelihood per event is smarter (boundary problem)
1744  } else {
1745  if( MuScleFitUtils::debug > 0 ) {
1746  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;
1747  std::cout << "Original mass was = " << mass << std::endl;
1748  std::cout << "WARNING: massResol = " << massResol << " outside window" << std::endl;
1749  }
1750  evtsoutlik += 1;
1751  }
1752  if (MuScleFitUtils::debug>19)
1753  std::cout << "[MuScleFitUtils-likelihood]: Mass probability = " << prob << std::endl;
1754  } // weight!=0
1755 
1756  } // End of loop on tree events
1757 
1758 // // Protection for low statistic. If the likelihood manages to throw out all the signal
1759 // // events and stays with ~ 10 events in the resonance window it could have a better likelihood
1760 // // because of ~ uniformly distributed events (a random combination could be good and spoil the fit).
1761 // // We require that the number of events included in the fit does not change more than 5% in each minuit loop.
1762 // bool lowStatPenalty = false;
1763 // if( MuScleFitUtils::minuitLoop_ > 0 ) {
1764 // double newEventsOutInRatio = double(evtsinlik);
1765 // // double newEventsOutInRatio = double(evtsoutlik)/double(evtsinlik);
1766 // double ratio = newEventsOutInRatio/MuScleFitUtils::oldEventsOutInRatio_;
1767 // MuScleFitUtils::oldEventsOutInRatio_ = newEventsOutInRatio;
1768 // if( ratio < 0.8 || ratio > 1.2 ) {
1769 // std::cout << "Warning: too much change from oldEventsInLikelihood to newEventsInLikelihood, ratio is = " << ratio << std::endl;
1770 // std::cout << "oldEventsInLikelihood = " << MuScleFitUtils::oldEventsOutInRatio_ << ", newEventsInLikelihood = " << newEventsOutInRatio << std::endl;
1771 // lowStatPenalty = true;
1772 // }
1773 // }
1774 
1775  // It is a product of probabilities, we compare the sqrt_N of them. Thus N becomes a denominator of the logarithm.
1776  if( evtsinlik != 0 ) {
1777 
1779  // && !(MuScleFitUtils::duringMinos_) ) {
1780  if( MuScleFitUtils::rminPtr_ == 0 ) {
1781  std::cout << "ERROR: rminPtr_ = " << MuScleFitUtils::rminPtr_ << ", code will crash" << std::endl;
1782  }
1783  double normalizationArg[] = {1/double(evtsinlik)};
1784  // Reset the normalizationArg only if it changed
1785  if( MuScleFitUtils::oldNormalization_ != normalizationArg[0] ) {
1786  int ierror = 0;
1787 // if( MuScleFitUtils::likelihoodInLoop_ != 0 ) {
1788 // // This condition is set only when minimizing. Later calls of hesse and minos will not change the value
1789 // // This is done to avoid minos being confused by changing the UP parameter during its computation.
1790 // MuScleFitUtils::rminPtr_->mnexcm("SET ERR", normalizationArg, 1, ierror);
1791 // }
1792  MuScleFitUtils::rminPtr_->mnexcm("SET ERR", normalizationArg, 1, ierror);
1793  std::cout << "oldNormalization = " << MuScleFitUtils::oldNormalization_ << " new = " << normalizationArg[0] << std::endl;
1794  MuScleFitUtils::oldNormalization_ = normalizationArg[0];
1796  }
1797  fval = -2.*flike/double(evtsinlik);
1798  // fval = -2.*flike;
1799  // if( lowStatPenalty ) {
1800  // fval *= 100;
1801  // }
1802  }
1803  else {
1804  fval = -2.*flike;
1805  }
1806  }
1807  else {
1808  std::cout << "Problem: Events in likelihood = " << evtsinlik << std::endl;
1809  fval = 999999999.;
1810  }
1811  // fval = -2.*flike;
1812  if (MuScleFitUtils::debug>19)
1813  std::cout << "[MuScleFitUtils-likelihood]: End tree loop with likelihood value = " << fval << std::endl;
1814 
1815 // #ifdef DEBUG
1816 
1817  if( MuScleFitUtils::minuitLoop_ < 10000 ) {
1821  }
1822  }
1823  // else std::cout << "minuitLoop over 10000. Not filling histogram" << std::endl;
1824 
1825  if( MuScleFitUtils::debug > 0 ) {
1826  // if( MuScleFitUtils::duringMinos_ ) {
1827  // int parnumber = (int)(MuScleFitUtils::parResol.size()+MuScleFitUtils::parScale.size()+
1828  // MuScleFitUtils::parCrossSection.size()+MuScleFitUtils::parBgr.size());
1829  // std::cout << "[MuScleFitUtils-likelihood]: Looping on tree with ";
1830  // for (int ipar=0; ipar<parnumber; ipar++) {
1831  // std::cout << "Parameter #" << ipar << " with value " << xval[ipar] << " ";
1832  // }
1833  // std::cout << std::endl;
1834  // std::cout << "[MuScleFitUtils-likelihood]: likelihood value = " << fval << std::endl;
1835  // }
1836  std::cout << "Events in likelihood = " << evtsinlik << std::endl;
1837  std::cout << "Events out likelihood = " << evtsoutlik << std::endl;
1838  }
1839 
1840 // #endif
1841 }
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:8
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_
Log< T >::type log(const T &t)
Definition: Log.h:22
static int iev_
static bool normalizeLikelihoodByEventNumber_
tuple cout
Definition: gather_cfg.py:41
Double_t lorentzianPeak ( Double_t *  x,
Double_t *  par 
)

See header file for a class description

Date:
2010/10/22 17:47:44
Revision:
1.45
Author
S. Bolognesi - INFN Torino / T. Dorigo, M. De Mattia - INFN Padova

Definition at line 57 of file MuScleFitUtils.cc.

References siStripFEDMonitor_P5_cff::Max, and Pi.

Referenced by MuScleFitUtils::fitMass().

57  {
58  return (0.5*par[0]*par[1]/TMath::Pi()) /
59  TMath::Max(1.e-10,(x[0]-par[2])*(x[0]-par[2]) + .25*par[1]*par[1]);
60 }
const double Pi
Definition: DDAxes.h:10
const double par[8 *NPar][4]

Variable Documentation

double f[11][100]

Definition at line 79 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< PROD_S(F, G), H >::prod0::a(), funct::RatioP1< F, G, H >::prod1::a(), funct::Product< PROD_S(F, G), H >::prod1::a(), funct::RatioP2< F, G, H >::prod0::a(), funct::RatioP2< F, G, H >::prod1::a(), abcd(), abConnect(), edm::helper::Filler< Association< C > >::add(), pftools::SpaceManager::addEvolution(), SiPixelFedCablingTree::addFed(), DDQuery::addFilter(), SiStripGainFromData::algoEndJob(), PedsFullNoiseAlgorithm::analyse(), ZMuPtScaleAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), EcalSRCondTools::analyze(), HcalMonitorModule::analyze(), GctFibreAnalyzer::analyze(), ZDCMonitorModule::analyze(), HeavyFlavorValidation::analyze(), DumpSimGeometry::analyze(), BTagPerformaceRootProducerFromSQLITE::analyze(), MuonTrackValidator::analyze(), OnDemandMeasurementTracker::assign(), DTDigitizer::asymGausSmear(), fastmath::atan2r(), ProtonTaggerFilter::beginJob(), TSGFromL1Muon::beginRun(), RPCDataCertification::beginRun(), RPCDCSSummary::beginRun(), RPCEventSummary::beginRun(), MaterialForOnline::beginRun(), TrackerOfflineValidation::bookDirHists(), MagGeoBuilderFromDDD::bRod::bRod(), MagGeoBuilderFromDDD::bSector::bSector(), FWConvTrackHitsDetailView::build(), FWTrackHitsDetailView::build(), MagGeoBuilderFromDDD::build(), ThreadSingleton< T, F >::buildMe(), funct::SimplSumOrd< F, G, H >::prod2::c(), funct::RatioP1< F, G, H >::prod2::c(), funct::Product< PROD_S(F, G), H >::prod2::c(), funct::RatioP2< F, G, H >::prod2::c(), HLTEcalResonanceFilter::calcShowerShape(), edm::ExceptionCollector::call(), GenParticleProducer::chargeTimesThree(), LaserSorter::closeOutStream(), Grid1D::closestNode(), CmsShowMain::CmsShowMain(), TrackerOfflineValidation::collateSummaryHists(), funct::SimplSumOrd< A, B, PROD_S(C, D) >::combine(), funct::combine(), funct::RatioP1< F, G, H >::combine(), funct::Product< PROD_S(F, G), H >::combine(), funct::RatioP2< F, G, H >::combine(), CompositeTrajectoryFilter::CompositeTrajectoryFilter(), GsfBetheHeitlerUpdator::compute(), EcalUncalibRecHitRatioMethodAlgo< C >::computeAmplitude(), VolumeEnergyLossEstimator::computeElectrons(), EnergyLossUpdator::computeElectrons(), EcalUncalibRecHitRatioMethodAlgo< C >::computeTime(), ConnectionManager::connect(), convert64(), edm::ParameterSetConverter::convertParameterSets(), edm::copy_all(), StripCPE::Param::coveredStrips(), EveService::createEventNavigationGUI(), muonisolation::IsolatorByNominalEfficiency::cuts(), GaussianSumUtilities1D::d1LnPdf(), GaussianSumUtilities1D::d2LnPdf(), dd_html_frameset(), dd_html_menu(), dd_html_menu_frameset(), dd_to_html(), DDDefaultNumberingScheme::DDDefaultNumberingScheme(), DumpGctDigis::doFibres(), DDNsGenerator::doit(), DDFrameGenerator::doit(), CmsShowTaskExecutor::doNextTaskImp(), DTDigitizer::driftTimeFromParametrization(), edm::JobReport::dumpFiles(), VVIObjDetails::dzero(), Conv::elec(), RPCMonitorRaw::endJob(), EcalTBHodoscopeRawInfoDumper::endJob(), EcalTBTDCRawInfoDumper::endJob(), miscalibExample::endJob(), EcalSimpleTBAnalyzer::endJob(), EcalSimple2007H4TBAnalyzer::endJob(), PhiSymmetryCalibration::endJob(), TrackerOfflineValidation::endJob(), fireworks::energyScaledBox3DCorners(), BinomialProbability::error(), MagGeoBuilderFromDDD::eSector::eSector(), fireworks::etScaledBox3DCorners(), fit::RootMinuitFuncEvaluator< Function >::evaluate(), fit::RootMinuitFuncEvaluator< Likelihood< Sample, PDF, Yield > >::evaluate(), edm::JobReport::eventReadFromFile(), edm::JobReport::eventWrittenToFile(), TFParams::f3deg(), ThreadSingleton< T, F >::factory(), HiEgammaSCEnergyCorrectionAlgo::fBrem(), VVIObj::fcn(), HiEgammaSCEnergyCorrectionAlgo::fEta(), HiEgammaSCEnergyCorrectionAlgo::fEtEta(), PixelRecoUtilities::FieldAt0::FieldAt0(), MultipleScatteringX0Data::fileName(), XHistogram::fill(), big::bigStore::fill(), MTVHistoProducerAlgoForTracker::fill_generic_recoTrack_histos(), MTVHistoProducerAlgoForTracker::fill_recoAssociated_simTrack_histos(), QcdUeDQM::fillChargedJetSpectra(), PhiSymmetryCalibration_step2::fillConstantsHistos(), PhiSymmetryCalibration_step2_SM::fillConstantsHistos(), PhiSymmetryCalibration_step2::fillHistos(), PhiSymmetryCalibration_step2_SM::fillHistos(), StripCPE::fillParam(), LRHelpFunctions::fillToBackgroundHists(), LRHelpFunctions::fillToSignalHists(), edm::AssociationMap< edm::OneToManyWithQualityGeneric< TrackingParticleCollection, edm::View< reco::Track >, double > >::find(), MSLayersAtAngle::findLayer(), muonisolation::IsolatorByNominalEfficiency::findPath(), SymmetryFit::fit(), Fit::Fit(), SymmetryFit::fitfunction(), extend_argparse::FixedWidthFormatter(), HiEgammaSCEnergyCorrectionAlgo::fNCrystals(), EgammaSCEnergyCorrectionAlgo::fNCrystals(), edm::for_all(), fpeak_convoluted(), lumi::from_string(), HcalDbOmds::from_string(), root::helper::RootFunctionHelper< F, args, Tag >::fun(), root::function(), FWEveViewManager::FWEveViewManager(), FWFFService::FWFFService(), FWGeometryTableViewManager::FWGeometryTableViewManager(), FWGUIEventFilter::FWGUIEventFilter(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), FWPFLegoCandidate::FWPFLegoCandidate(), 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(), TouchableToHistory::getFilteredView(), HoECalculator::getHoE(), WatcherStreamFileReader::getInputFile(), PhiSymmetryCalibration::getKfactors(), EcalTrivialConditionRetriever::getMappingFromConfiguration(), FWMagField::GetMaxFieldMag(), EcalMappingElectronicsHandler::getNewObjects(), popcon::EcalTPGFineGrainEBIdMapHandler::getNewObjects(), EcalClusterLocalContCorrection::getValue(), EcalClusterCrackCorrection::getValue(), CSCAnalogSignal::getValue(), CmsAnnotation::Handle(), FWColorPopup::HandleButton(), HcalEEUSMonitor::HcalEEUSMonitor(), HcalRawDataMonitor::HcalRawDataMonitor(), HelixBarrelPlaneCrossing2OrderLocal::HelixBarrelPlaneCrossing2OrderLocal(), HitPairGeneratorFromLayerPair::hitPairs(), ctfseeding::HitExtractorPIX::hits(), PixelTripletHLTGenerator::hitTriplets(), IEEE32toDSP(), pat::strbitset::index(), ThirdHitCorrection::init(), PixelRecoLineRZ::initCot(), fireworks::Context::initEveElements(), CandMatcherBase< C1, C2 >::initMaps(), edm::JobReport::inputFileClosed(), edm::helper::Filler< Association< C > >::insert(), SimpleDiskBounds::inside(), DiskSectorBounds::inside(), ThreadSingleton< T, F >::instance(), funct::integral(), LinearGridInterpolator3D::interpolate(), SiPixelTemplate::interpolate(), edm::isTransientEqual(), FWGUIValidatingTextEntry::keyPressedInPopup(), GaussianSumUtilities1D::lnPdf(), HcalDetDiagPedestalMonitor::LoadDataset(), HcalDetDiagLaserMonitor::LoadDataset(), FWFFLooper::loadDefaultGeometryFile(), MatacqProducer::loadOrbitOffset(), HcalPatternSource::loadPatternFile(), ClusterShapeHitFilter::loadPixelLimits(), HcalDetDiagLEDMonitor::LoadReference(), HcalDetDiagPedestalMonitor::LoadReference(), HcalDetDiagLaserMonitor::LoadReference(), stor::SharedResources::localDebug(), PSimHit::localDirection(), RectangularStripTopology::localError(), RadialStripTopology::localError(), StripCPEfromTrackAngle::localParameters(), StripCPE::localParameters(), TrapezoidalStripTopology::localPitch(), RadialStripTopology::localPitch(), RectangularStripTopology::localPosition(), TrapezoidalStripTopology::localStripLength(), RadialStripTopology::localStripLength(), main(), MuonRPCDetLayerGeometryBuilder::makeBarrelLayers(), MuonRPCDetLayerGeometryBuilder::makeBarrelRods(), fireworks_root_gui::makeHorizontalFrame(), edm::EventSelector::maskTriggerResults(), funct::master(), RadialStripTopology::measurementError(), JetPartonNamespace::UserPartonMixture::mixt(), MuonRoadTrajectoryBuilder::MuonRoadTrajectoryBuilder(), HcalRecHitsMaker::noiseInfCfromDB(), edm::AssociationMap< edm::OneToManyWithQualityGeneric< TrackingParticleCollection, edm::View< reco::Track >, double > >::numberOfAssociations(), LRHelpFunctions::obsFitIncluded(), GsiFTPStorageMaker::open(), HttpStorageMaker::open(), LocalStorageMaker::open(), DCacheStorageMaker::open(), StormStorageMaker::open(), StormLcgGtStorageMaker::open(), RFIOStorageMaker::open(), FreeFunctionSelector< T, f >::operator()(), CandMatcherBase< C1, C2 >::operator()(), BSpdfsFcn::operator()(), funct::GaussLegendreIntegrator::operator()(), funct::GaussIntegrator::operator()(), funct::operator<<(), edm::service::ErrorLog::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::AssociationMap< edm::OneToManyWithQualityGeneric< TrackingParticleCollection, edm::View< reco::Track >, double > >::operator[](), edm::JobReport::outputFileClosed(), PhiSymmetryCalibration_step2_SM::outResidHistos(), PhiSymmetryCalibration_step2::outResidHistos(), edm::JobReport::overrideContributingInputs(), edm::JobReport::overrideEventsRead(), edm::JobReport::overrideEventsWritten(), GenParticlePruner::parse(), EcalTrigTowerConstituentsMapBuilder::parseTextMap(), PetrukhinFunc(), PFResolutionMapManager::PFResolutionMapManager(), CSCSegAlgoSK::phiAtZ(), CSCSegAlgoTC::phiAtZ(), SiPixelTemplateReco::PixelTempReco2D(), cond::PayLoadInspector< DataT >::plot(), plotMaker(), TwoTrackMinimumDistance::pointsHelixHelix(), FWRPZView::populateController(), FWTriggerTableView::populateController(), FWFFService::postBeginJob(), VariableHelperService::postProcess(), InputTagDistributorService::preModule(), VariableHelperService::preModule(), fireworks::prepareTrack(), HcalRawDataMonitor::processEvent(), HcalRecHitMonitor::processEvent_rechit(), MCTrackMatcher::produce(), L1HLTJetsMatching::produce(), GenTrackMatcher::produce(), BeamSpotOnlineProducer::produce(), L3TkMuonProducer::produce(), MatchedProbeMaker< T >::produce(), perftools::EdmEventSize::produceHistos(), gen::PtYDistributor::PtYDistributor(), EcalUncalibRecHitRecAnalFitAlgo< EBDataFrame >::pulseShapeFunction(), Histos::put(), PixelRecoLineRZ::rAtZ(), edm::ValueMap< reco::MuonMETCorrectionData >::rawIndexOf(), TStorageFactoryFile::ReadBufferAsync(), DQMStore::readFile(), FWConfigurationManager::readFromFile(), EcalFEtoDigi::readInput(), PasswordReader::readPassword(), HcalSimpleRecAlgo::reconstruct(), CmsShowNavigator::removeFilter(), edm::JobReport::reportDataType(), edm::JobReport::reportFastCopyingStatus(), FWGeometryTableView::resetSetters(), LA_Filler_Fitter::result(), fit::RootMinuit< Function >::RootMinuit(), LocalError::rotate(), LocalError::rotateCosSin(), PixelFitterByHelixProjections::run(), DQMStore::save(), TkHistoMap::saveAsCanvas(), FWViewContextMenuHandlerGL::select(), edm::EventSelector::selectionDecision(), VariableHelperService::set(), FWGeometryTableManager::NodeInfo::setBit(), TrackInformation::setCaloIDChecked(), MeasurementTracker::setClusterToSkip(), CmsShowMainBase::setConfigFilename(), UnbinnedLikelihoodFit::setFunction(), hcalCalib::SetMaxProbeJetEmFrac(), hcalCalib::SetMaxTagJetEmFrac(), BscG4Hit::setPhiAtEntry(), FP420G4Hit::setPhiAtEntry(), TotemG4Hit::setPhiAtEntry(), BaseParticlePropagator::setPropagationConditions(), FWMET3DProxyBuilder::Arrow::setScale(), CastorPulseShapes::Shape::setShapeBin(), HcalPulseShapes::Shape::setShapeBin(), HcalEEUSMonitor::setup(), HcalRawDataMonitor::setup(), FWEveView::setupEnergyScale(), ctfseeding::HitExtractorSTRP::skipThis(), XHistogram::splitSegment(), FWFFLooper::startingNewLoop(), cscdqm::stringToNumber(), StripCPEfromTrackAngle::stripErrorSquared(), FWGUIManager::subviewIsBeingDestroyed(), MSLayersAtAngle::sum2RmRn(), SummaryPlotXmlParser::SummaryPlotXmlParser(), MSLayer::sumX0D(), FWGeometryTableManager::NodeInfo::testBit(), edm::EventSelector::testSelectionOverlap(), root::tf1(), TFileAdaptor::TFileAdaptor(), funct::trapezoid_integral(), PrimaryVertexAnalyzer4PU::truthMatchedTrack(), reco::typeCode(), HcalUnpacker::unpack(), HcalRawDataMonitor::UpdateMEs(), MeasurementTracker::updatePixels(), FWPFRhoPhiRecHit::updateScale(), MeasurementTracker::updateStrips(), root::helper::RootVarsAdapter< F, 1 >::value(), root::helper::RootVarsAdapter< F, 2 >::value(), JetPartonNamespace::ParametrizationJetParton::value(), WatcherStreamFileReader::WatcherStreamFileReader(), ProvenanceDumper::work_(), sistrip::MeasureLA::write_report_text_ms(), edm::JobReport::JobReportImpl::writeInputFile(), edm::JobReport::JobReportImpl::writeOutputFile(), MSLayer::x0(), geometryXMLparser.MuonGeometry::xml(), and edm::service::InitRootHandlers::~InitRootHandlers().

double g[11][100]

Definition at line 80 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 84 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 88 of file MuScleFitUtils.cc.

double isum
double mzsum

Definition at line 77 of file MuScleFitUtils.cc.