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 64 of file MuScleFitUtils.cc.

References create_public_lumi_plots::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 }
Definition: DDAxes.h:10
void likelihood ( int &  npar,
double *  grad,
double &  fval,
double *  xval,
int  flag 
)

Definition at line 1698 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_, create_public_lumi_plots::log, MuScleFitUtils::loopCounter, scaleCards::mass, 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().

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

See header file for a class description

Date:
2012/12/20 16:09:28
Revision:
1.27
Author
S. Bolognesi - INFN Torino / T. Dorigo, M. De Mattia - INFN Padova

Definition at line 57 of file MuScleFitUtils.cc.

References alignCSCRings::e, 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

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(), ZDCMonitorModule::analyze(), GctFibreAnalyzer::analyze(), HeavyFlavorValidation::analyze(), DumpSimGeometry::analyze(), BTagPerformaceRootProducerFromSQLITE::analyze(), FFTJetPileupAnalyzer::analyze(), MuonTrackValidator::analyze(), TrackAssociatorByChi2::associateRecoToSim(), TrackAssociatorByChi2::associateSimToReco(), DTDigitizer::asymGausSmear(), HcalShapeIntegrator::at(), fastmath::atan2r(), ProtonTaggerFilter::beginJob(), TSGFromL1Muon::beginRun(), RPCDataCertification::beginRun(), RPCDCSSummary::beginRun(), RPCEventSummary::beginRun(), MaterialForOnline::beginRun(), TrackerOfflineValidation::bookDirHists(), MagGeoBuilderFromDDD::bRod::bRod(), MagGeoBuilderFromDDD::bSector::bSector(), FWCaloRecHitDigitSetProxyBuilder::build(), FWTrackHitsDetailView::build(), FWConvTrackHitsDetailView::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(), Quantile::calculateQ(), edm::ExceptionCollector::call(), GenParticleProducer::chargeTimesThree(), HitPairGeneratorFromLayerPairForPhotonConversion::checkRZCompatibilityWithSeedTrack(), CmsShowEDI::clearPBFrame(), 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(), TrackAssociatorByChi2::compareTracksParam(), CompositeTrajectoryFilter::CompositeTrajectoryFilter(), GsfBetheHeitlerUpdator::compute(), EcalUncalibRecHitRatioMethodAlgo< C >::computeAmplitude(), FWGeoTopNode::ComputeBBox(), VolumeEnergyLossEstimator::computeElectrons(), EnergyLossUpdator::computeElectrons(), MagneticField::computeNominalValue(), EcalUncalibRecHitRatioMethodAlgo< C >::computeTime(), ConnectionManager::connect(), convert64(), edm::ParameterSetConverter::convertParameterSets(), edm::copy_all(), 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(), FFTJetProducer::determinePileup(), DumpGctDigis::doFibres(), DDNsGenerator::doit(), DDFrameGenerator::doit(), CmsShowTaskExecutor::doNextTaskImp(), DTDigitizer::driftTimeFromParametrization(), edm::JobReport::dumpFiles(), VVIObjDetails::dzero(), EcalSeverityLevelAlgo::EcalSeverityLevelAlgo(), Conv::elec(), EcalTBHodoscopeRawInfoDumper::endJob(), EcalTBTDCRawInfoDumper::endJob(), RPCMonitorRaw::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(), Roo4lMasses2D_Bkg::evaluate(), Roo4lMasses2D_BkgGGZZ::evaluate(), HybridNew::evalWithFork(), edm::JobReport::eventReadFromFile(), edm::JobReport::eventWrittenToFile(), TFParams::f3deg(), ThreadSingleton< T, F >::factory(), HitQuadrupletGeneratorFromLayerPairForPhotonConversion::failCheckRZCompatibility(), 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(), evf::iDie::fillDQMModFractionHist(), PhiSymmetryCalibration_step2::fillHistos(), PhiSymmetryCalibration_step2_SM::fillHistos(), StripCPE::fillParams(), 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(), 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(), 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(), cacheutils::ValuesCache::get(), HitPairGeneratorFromLayerPairForPhotonConversion::getCot(), TouchableToHistory::getFilteredView(), HoECalculator::getHoE(), WatcherStreamFileReader::getInputFile(), PhiSymmetryCalibration::getKfactors(), EcalTrivialConditionRetriever::getMappingFromConfiguration(), FWMagField::GetMaxFieldMag(), EcalMappingElectronicsHandler::getNewObjects(), popcon::EcalSRPHandler::getNewObjects(), popcon::EcalTPGFineGrainEBIdMapHandler::getNewObjects(), EcalClusterLocalContCorrection::getValue(), EcalClusterCrackCorrection::getValue(), CSCAnalogSignal::getValue(), GlobalTrajectoryParameters::GlobalTrajectoryParameters(), CmsAnnotation::Handle(), FWColorPopup::HandleButton(), HcalEEUSMonitor::HcalEEUSMonitor(), HelixBarrelPlaneCrossing2OrderLocal::HelixBarrelPlaneCrossing2OrderLocal(), HitPairGeneratorFromLayerPair::hitPairs(), HitPairGeneratorFromLayerPairForPhotonConversion::hitPairs(), 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(), Bounds::inside(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::inspectTrack(), ThreadSingleton< T, F >::instance(), funct::integral(), LinearGridInterpolator3D::interpolate(), SiStripTemplate::interpolate(), SiPixelTemplate::interpolate(), edm::isTransientEqual(), PerigeeConversions::jacobianPerigee2Curvilinear(), FWGUIValidatingTextEntry::keyPressedInPopup(), GaussianSumUtilities1D::lnPdf(), HcalDetDiagPedestalMonitor::LoadDataset(), HcalDetDiagLaserMonitor::LoadDataset(), FWFFLooper::loadDefaultGeometryFile(), MatacqProducer::loadOrbitOffset(), HcalPatternSource::loadPatternFile(), ClusterShapeHitFilter::loadPixelLimits(), HcalDetDiagLEDMonitor::LoadReference(), HcalDetDiagPedestalMonitor::LoadReference(), HcalDetDiagLaserMonitor::LoadReference(), stor::AlarmHandler::localDebug(), PSimHit::localDirection(), RadialStripTopology::localError(), StripCPEfromTrackAngle::localParameters(), StripCPEfromTemplate::localParameters(), StripCPE::localParameters(), RadialStripTopology::localPitch(), RadialStripTopology::localStripLength(), GlobalTrajectoryParameters::magneticFieldInInverseGeV(), main(), MuonRPCDetLayerGeometryBuilder::makeBarrelLayers(), MuonRPCDetLayerGeometryBuilder::makeBarrelRods(), fireworks_root_gui::makeHorizontalFrame(), edm::EventSelector::maskTriggerResults(), funct::master(), RadialStripTopology::measurementError(), JetPartonNamespace::UserPartonMixture::mixt(), MuonRoadTrajectoryBuilder::MuonRoadTrajectoryBuilder(), HcalRecHitsMaker::noiseInfCfromDB(), FastHisto::Normalize(), FastHisto2D::Normalize(), edm::AssociationMap< edm::OneToManyWithQualityGeneric< TrackingParticleCollection, edm::View< reco::Track >, double > >::numberOfAssociations(), LRHelpFunctions::obsFitIncluded(), CaloSamples::offsetTime(), HttpStorageMaker::open(), GsiFTPStorageMaker::open(), XrdStorageMaker::open(), LocalStorageMaker::open(), DCacheStorageMaker::open(), StormStorageMaker::open(), StormLcgGtStorageMaker::open(), RFIOStorageMaker::open(), FreeFunctionSelector< T, f >::operator()(), BSpdfsFcn::operator()(), CandMatcherBase< C1, C2 >::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::outResidHistos(), PhiSymmetryCalibration_step2_SM::outResidHistos(), edm::JobReport::overrideContributingInputs(), edm::JobReport::overrideEventsRead(), edm::JobReport::overrideEventsWritten(), GenParticlePruner::parse(), EcalTrigTowerConstituentsMapBuilder::parseTextMap(), PetrukhinFunc(), PFResolutionMapManager::PFResolutionMapManager(), CSCSegAlgoSK::phiAtZ(), CSCSegAlgoTC::phiAtZ(), SiPixelTemplateReco::PixelTempReco2D(), SiPixelTemplateSplit::PixelTempSplit(), 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(), L1HLTTauMatching::produce(), PFJetsMatchedToFilteredCaloJetsProducer::produce(), GenTrackMatcher::produce(), BeamSpotOnlineProducer::produce(), L3TkMuonProducer::produce(), MatchedProbeMaker< T >::produce(), EcalTrivialConditionRetriever::produceEcalAlignmentEB(), EcalTrivialConditionRetriever::produceEcalAlignmentEE(), EcalTrivialConditionRetriever::produceEcalAlignmentES(), perftools::EdmEventSize::produceHistos(), gen::PtYDistributor::PtYDistributor(), EcalUncalibRecHitRecAnalFitAlgo< EBDataFrame >::pulseShapeFunction(), Histos::put(), SiStripTemplate::qbin(), SiPixelTemplate::qbin(), SiPixelTemplate::qbin_dist(), PixelRecoLineRZ::rAtZ(), edm::ValueMap< reco::MuonMETCorrectionData >::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(), HcalSimpleRecAlgo::reconstruct(), CmsShowNavigator::removeFilter(), edm::JobReport::reportDataType(), edm::JobReport::reportFastCopyingStatus(), HcalRawDataMonitor::reset(), ViewerParameterGUI::reset(), CastorSimpleRecAlgo::resetTimeSamples(), 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(), FWGeometryTableManagerBase::NodeInfo::setBit(), TrackInformation::setCaloIDChecked(), CmsShowMainBase::setConfigFilename(), UnbinnedLikelihoodFit::setFunction(), 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(), PhotonFix::sigmaEnergy(), SiPixelTemplate::simpletemplate2D(), XHistogram::splitSegment(), FWFFLooper::startingNewLoop(), stringToNumber(), cscdqm::stringToNumber(), SiStripTemplateReco::StripTempReco1D(), SiStripTemplateSplit::StripTempSplit(), FWGUIManager::subviewIsBeingDestroyed(), MSLayersAtAngle::sum2RmRn(), SummaryPlotXmlParser::SummaryPlotXmlParser(), MSLayer::sumX0D(), SiStripTemplate::sxtemp(), SiPixelTemplate::temperrors(), FWGeometryTableManagerBase::NodeInfo::testBit(), edm::EventSelector::testSelectionOverlap(), TkStripMeasurementDet::testStrips(), root::tf1(), TFileAdaptor::TFileAdaptor(), GlobalTrajectoryParameters::transverseCurvature(), funct::trapezoid_integral(), PrimaryVertexAnalyzer4PU::truthMatchedTrack(), reco::typeCode(), HcalUnpacker::unpack(), spu::Untar(), HcalRawDataMonitor::UpdateMEs(), evf::iDie::updateRollingHistos(), FWPFRhoPhiRecHit::updateScale(), root::helper::RootVarsAdapter< F, 1 >::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(), WatcherStreamFileReader::WatcherStreamFileReader(), ProvenanceDumper::work_(), sistrip::MeasureLA::write_report_text_ms(), edm::JobReport::JobReportImpl::writeInputFile(), edm::JobReport::JobReportImpl::writeOutputFile(), MSLayer::x0(), SiStripTemplate::xflcorr(), SiPixelTemplate::xflcorr(), geometryXMLparser.MuonGeometry::xml(), SiStripTemplate::xsigma2(), SiPixelTemplate::xsigma2(), SiPixelTemplate2D::xysigma2(), SiPixelTemplate2D::xytemp(), SiPixelTemplate::yflcorr(), SiPixelTemplate::ysigma2(), 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.