CMS 3D CMS Logo

Functions | Variables

/data/refman/pasoursint/CMSSW_5_3_8_patch3/src/MuonAnalysis/MomentumScaleCalibration/plugins/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 funct::exp().

Referenced by MuScleFitUtils::fitReso().

                                               {
  return par[0]*exp(-0.5*((x[0]-par[1])/par[2])*((x[0]-par[1])/par[2]));
}
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_, funct::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().

                                                                                            {

  if (MuScleFitUtils::debug>19) std::cout << "[MuScleFitUtils-likelihood]: In likelihood function" << std::endl;

  const lorentzVector * recMu1;
  const lorentzVector * recMu2;
  lorentzVector corrMu1;
  lorentzVector corrMu2;

  //   if (MuScleFitUtils::debug>19) {
  //     int parnumber = (int)(MuScleFitUtils::parResol.size()+MuScleFitUtils::parScale.size()+
  //                           MuScleFitUtils::parCrossSection.size()+MuScleFitUtils::parBgr.size());
  //     std::cout << "[MuScleFitUtils-likelihood]: Looping on tree with ";
  //     for (int ipar=0; ipar<parnumber; ipar++) {
  //       std::cout << "Parameter #" << ipar << " with value " << xval[ipar] << " ";
  //     }
  //     std::cout << std::endl;
  //   }

  // Loop on the tree
  // ----------------
  double flike = 0;
  int evtsinlik = 0;
  int evtsoutlik = 0;
  // std::cout << "SavedPair.size() = " << MuScleFitUtils::SavedPair.size() << std::endl;
  if( MuScleFitUtils::debug>0 ) {
    std::cout << "SavedPair.size() = " << MuScleFitUtils::SavedPair.size() << std::endl;
    std::cout << "ReducedSavedPair.size() = " << MuScleFitUtils::ReducedSavedPair.size() << std::endl;
  }
  // for( unsigned int nev=0; nev<MuScleFitUtils::SavedPair.size(); ++nev ) {
  for( unsigned int nev=0; nev<MuScleFitUtils::ReducedSavedPair.size(); ++nev ) {

    //     recMu1 = &(MuScleFitUtils::SavedPair[nev].first);
    //     recMu2 = &(MuScleFitUtils::SavedPair[nev].second);
    recMu1 = &(MuScleFitUtils::ReducedSavedPair[nev].first);
    recMu2 = &(MuScleFitUtils::ReducedSavedPair[nev].second);

    // Compute original mass
    // ---------------------
    double mass = MuScleFitUtils::invDimuonMass( *recMu1, *recMu2 );

    // Compute weight and reference mass (from original mass)
    // ------------------------------------------------------
    double weight = MuScleFitUtils::computeWeight(mass, MuScleFitUtils::iev_);
    if( weight!=0. ) {
      // Compute corrected mass (from previous biases) only if we are currently fitting the scale
      // ----------------------------------------------------------------------------------------
      if( MuScleFitUtils::doScaleFit[MuScleFitUtils::loopCounter] ) {
//      std::cout << "Original pt1 = " << corrMu1.Pt() << std::endl;
//      std::cout << "Original pt2 = " << corrMu2.Pt() << std::endl;
        corrMu1 = MuScleFitUtils::applyScale(*recMu1, xval, -1);
        corrMu2 = MuScleFitUtils::applyScale(*recMu2, xval,  1);
        
//         if( (corrMu1.Pt() != corrMu1.Pt()) || (corrMu2.Pt() != corrMu2.Pt()) ) {
//           std::cout << "Rescaled pt1 = " << corrMu1.Pt() << std::endl;
//           std::cout << "Rescaled pt2 = " << corrMu2.Pt() << std::endl;
//         }
//      std::cout << "Rescaled pt1 = " << corrMu1.Pt() << std::endl;
//      std::cout << "Rescaled pt2 = " << corrMu2.Pt() << std::endl;
      }
      else {
        corrMu1 = *recMu1;
        corrMu2 = *recMu2;

//         if( (corrMu1.Pt() != corrMu1.Pt()) || (corrMu2.Pt() != corrMu2.Pt()) ) {
//           std::cout << "Not rescaled pt1 = " << corrMu1.Pt() << std::endl;
//           std::cout << "Not rescaled pt2 = " << corrMu2.Pt() << std::endl;
//         }
      }
      double corrMass = MuScleFitUtils::invDimuonMass(corrMu1, corrMu2);
      double Y = (corrMu1+corrMu2).Rapidity();
      double resEta = (corrMu1+corrMu2).Eta();
      if( MuScleFitUtils::debug>19 ) {
        std::cout << "[MuScleFitUtils-likelihood]: Original/Corrected resonance mass = " << mass
             << " / " << corrMass << std::endl;
      }

      // Compute mass resolution
      // -----------------------
      double massResol = MuScleFitUtils::massResolution(corrMu1, corrMu2, xval);
      if (MuScleFitUtils::debug>19)
        std::cout << "[MuScleFitUtils-likelihood]: Resolution is " << massResol << std::endl;

      // Compute probability of this mass value including background modeling
      // --------------------------------------------------------------------
      if (MuScleFitUtils::debug>1) std::cout << "calling massProb inside likelihood function" << std::endl;

      // double prob = MuScleFitUtils::massProb( corrMass, resEta, Y, massResol, xval );
      double prob = MuScleFitUtils::massProb( corrMass, resEta, Y, massResol, xval, false, corrMu1.eta(), corrMu2.eta() );
      if (MuScleFitUtils::debug>1) std::cout << "likelihood:massProb = " << prob << std::endl;

      // Compute likelihood
      // ------------------
      if( prob>0 ) {
        // flike += log(prob*10000)*weight; // NNBB! x10000 to see if we can recover the problem of boundary
        flike += log(prob)*weight;
        evtsinlik += 1;  // NNBB test: see if likelihood per event is smarter (boundary problem)
      } else {
        if( MuScleFitUtils::debug > 0 ) {
          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;
          std::cout << "Original mass was = " << mass << std::endl;
          std::cout << "WARNING: massResol = " << massResol << " outside window" << std::endl;
        }
        evtsoutlik += 1;
      }
      if (MuScleFitUtils::debug>19)
        std::cout << "[MuScleFitUtils-likelihood]: Mass probability = " << prob << std::endl;
    } // weight!=0

  } // End of loop on tree events

//   // Protection for low statistic. If the likelihood manages to throw out all the signal
//   // events and stays with ~ 10 events in the resonance window it could have a better likelihood
//   // because of ~ uniformly distributed events (a random combination could be good and spoil the fit).
//   // We require that the number of events included in the fit does not change more than 5% in each minuit loop.
//   bool lowStatPenalty = false;
//   if( MuScleFitUtils::minuitLoop_ > 0 ) {
//     double newEventsOutInRatio = double(evtsinlik);
//     // double newEventsOutInRatio = double(evtsoutlik)/double(evtsinlik);
//     double ratio = newEventsOutInRatio/MuScleFitUtils::oldEventsOutInRatio_;
//     MuScleFitUtils::oldEventsOutInRatio_ = newEventsOutInRatio;
//     if( ratio < 0.8 || ratio > 1.2 ) {
//       std::cout << "Warning: too much change from oldEventsInLikelihood to newEventsInLikelihood, ratio is = " << ratio << std::endl;
//       std::cout << "oldEventsInLikelihood = " << MuScleFitUtils::oldEventsOutInRatio_ << ", newEventsInLikelihood = " << newEventsOutInRatio << std::endl;
//       lowStatPenalty = true;
//     }
//   }

  // It is a product of probabilities, we compare the sqrt_N of them. Thus N becomes a denominator of the logarithm.
  if( evtsinlik != 0 ) {

    if( MuScleFitUtils::normalizeLikelihoodByEventNumber_ ) {
      // && !(MuScleFitUtils::duringMinos_) ) {
      if( MuScleFitUtils::rminPtr_ == 0 ) {
        std::cout << "ERROR: rminPtr_ = " << MuScleFitUtils::rminPtr_ << ", code will crash" << std::endl;
      }
      double normalizationArg[] = {1/double(evtsinlik)};
      // Reset the normalizationArg only if it changed
      if( MuScleFitUtils::oldNormalization_ != normalizationArg[0] ) {
        int ierror = 0;
//         if( MuScleFitUtils::likelihoodInLoop_ != 0 ) {
//           // This condition is set only when minimizing. Later calls of hesse and minos will not change the value
//           // This is done to avoid minos being confused by changing the UP parameter during its computation.
//           MuScleFitUtils::rminPtr_->mnexcm("SET ERR", normalizationArg, 1, ierror);
//         }
        MuScleFitUtils::rminPtr_->mnexcm("SET ERR", normalizationArg, 1, ierror);
        std::cout << "oldNormalization = " << MuScleFitUtils::oldNormalization_ << " new = " << normalizationArg[0] << std::endl;
        MuScleFitUtils::oldNormalization_ = normalizationArg[0];
        MuScleFitUtils::normalizationChanged_ += 1;
      }
      fval = -2.*flike/double(evtsinlik);
      // fval = -2.*flike;
      //     if( lowStatPenalty ) {
      //       fval *= 100;
      //     }
    }
    else {
      fval = -2.*flike;
    }
  }
  else {
    std::cout << "Problem: Events in likelihood = " << evtsinlik << std::endl;
    fval = 999999999.;
  }
  // fval = -2.*flike;
  if (MuScleFitUtils::debug>19)
    std::cout << "[MuScleFitUtils-likelihood]: End tree loop with likelihood value = " << fval << std::endl;

//  #ifdef DEBUG

//  if( MuScleFitUtils::minuitLoop_ < 10000 ) {
  if( MuScleFitUtils::likelihoodInLoop_ != 0 ) {
    ++MuScleFitUtils::minuitLoop_;
    MuScleFitUtils::likelihoodInLoop_->SetBinContent(MuScleFitUtils::minuitLoop_, fval);
  }
  //  }
  // else std::cout << "minuitLoop over 10000. Not filling histogram" << std::endl;

  std::cout<<"MINUIT loop number "<<MuScleFitUtils::minuitLoop_<<", likelihood = "<<fval<<std::endl;

  if( MuScleFitUtils::debug > 0 ) {
    //     if( MuScleFitUtils::duringMinos_ ) {
    //       int parnumber = (int)(MuScleFitUtils::parResol.size()+MuScleFitUtils::parScale.size()+
    //                             MuScleFitUtils::parCrossSection.size()+MuScleFitUtils::parBgr.size());
    //       std::cout << "[MuScleFitUtils-likelihood]: Looping on tree with ";
    //       for (int ipar=0; ipar<parnumber; ipar++) {
    //         std::cout << "Parameter #" << ipar << " with value " << xval[ipar] << " ";
    //       }
    //       std::cout << std::endl;
    //       std::cout << "[MuScleFitUtils-likelihood]: likelihood value = " << fval << std::endl;
    //     }
    std::cout << "Events in likelihood = " << evtsinlik << std::endl;
    std::cout << "Events out likelihood = " << evtsoutlik << std::endl;
  }

//  #endif
}
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().

                                                     {
  return (0.5*par[0]*par[1]/TMath::Pi()) /
  TMath::Max(1.e-10,(x[0]-par[2])*(x[0]-par[2]) + .25*par[1]*par[1]);
}

Variable Documentation

double f[11][100]

Definition at line 79 of file MuScleFitUtils.cc.

Referenced by funct::SimplSumOrd< F, G, H >::prod0::a(), funct::Product< PROD_S(F, G), H >::prod0::a(), funct::RatioP1< F, G, H >::prod1::a(), funct::RatioP2< F, G, H >::prod1::a(), funct::SimplSumOrd< F, G, H >::prod1::a(), funct::Product< PROD_S(F, G), H >::prod1::a(), funct::RatioP2< F, G, H >::prod0::a(), funct::RatioP1< F, G, H >::prod0::a(), abcd(), abConnect(), edm::helper::Filler< Association< C > >::add(), pftools::SpaceManager::addEvolution(), SiPixelFedCablingTree::addFed(), DDQuery::addFilter(), SiStripGainFromData::algoEndJob(), PedsFullNoiseAlgorithm::analyse(), GctFibreAnalyzer::analyze(), ZMuPtScaleAnalyzer::analyze(), EwkMuLumiMonitorDQM::analyze(), DumpSimGeometry::analyze(), MuonTrackValidator::analyze(), HcalMonitorModule::analyze(), EcalSRCondTools::analyze(), FFTJetPileupAnalyzer::analyze(), ZDCMonitorModule::analyze(), HeavyFlavorValidation::analyze(), BTagPerformaceRootProducerFromSQLITE::analyze(), TrackAssociatorByChi2::associateRecoToSim(), TrackAssociatorByChi2::associateSimToReco(), DTDigitizer::asymGausSmear(), HcalShapeIntegrator::at(), fastmath::atan2r(), ProtonTaggerFilter::beginJob(), TSGFromL1Muon::beginRun(), MaterialForOnline::beginRun(), RPCEventSummary::beginRun(), RPCDataCertification::beginRun(), RPCDCSSummary::beginRun(), TrackerOfflineValidation::bookDirHists(), MagGeoBuilderFromDDD::bRod::bRod(), MagGeoBuilderFromDDD::bSector::bSector(), FWConvTrackHitsDetailView::build(), MagGeoBuilderFromDDD::build(), FWTrackHitsDetailView::build(), ThreadSingleton< T, F >::buildMe(), funct::RatioP1< F, G, H >::prod2::c(), funct::RatioP2< F, G, H >::prod2::c(), funct::SimplSumOrd< F, G, H >::prod2::c(), funct::Product< PROD_S(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::Product< PROD_S(F, G), H >::combine(), funct::RatioP1< F, G, H >::combine(), funct::RatioP2< F, G, H >::combine(), funct::SimplSumOrd< A, B, PROD_S(C, D) >::combine(), TrackAssociatorByChi2::compareTracksParam(), CompositeTrajectoryFilter::CompositeTrajectoryFilter(), GsfBetheHeitlerUpdator::compute(), EcalUncalibRecHitRatioMethodAlgo< C >::computeAmplitude(), FWGeoTopNode::ComputeBBox(), EnergyLossUpdator::computeElectrons(), VolumeEnergyLossEstimator::computeElectrons(), MagneticField::computeNominalValue(), EcalUncalibRecHitRatioMethodAlgo< C >::computeTime(), ConnectionManager::connect(), convert64(), edm::ParameterSetConverter::convertParameterSets(), edm::copy_all(), StripCPE::Param::coveredStrips(), spu::create_file(), EveService::createEventNavigationGUI(), 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(), miscalibExample::endJob(), EcalSimple2007H4TBAnalyzer::endJob(), EcalTBTDCRawInfoDumper::endJob(), TrackerOfflineValidation::endJob(), EcalTBHodoscopeRawInfoDumper::endJob(), RPCMonitorRaw::endJob(), EcalSimpleTBAnalyzer::endJob(), PhiSymmetryCalibration::endJob(), fireworks::energyScaledBox3DCorners(), BinomialProbability::error(), MagGeoBuilderFromDDD::eSector::eSector(), fireworks::etScaledBox3DCorners(), Roo4lMasses2D_Bkg::evaluate(), fit::RootMinuitFuncEvaluator< Function >::evaluate(), fit::RootMinuitFuncEvaluator< Likelihood< Sample, PDF, Yield > >::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(), big::bigStore::fill(), XHistogram::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_SM::fillHistos(), PhiSymmetryCalibration_step2::fillHistos(), StripCPE::fillParams(), LRHelpFunctions::fillToBackgroundHists(), LRHelpFunctions::fillToSignalHists(), edm::AssociationMap< edm::OneToManyWithQualityGeneric< TrackingParticleCollection, edm::View< reco::Track >, double > >::find(), MSLayersAtAngle::findLayer(), muonisolation::IsolatorByNominalEfficiency::findPath(), Fit::Fit(), SymmetryFit::fit(), SymmetryFit::fitfunction(), PhotonFix::fixedEnergy(), 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(), FWLegoCandidate::FWLegoCandidate(), FWLegoEvePFCandidate::FWLegoEvePFCandidate(), FWTableViewManager::FWTableViewManager(), FWTriggerTableViewManager::FWTriggerTableViewManager(), EcalSimRawData::genFeData(), EcalSimRawData::genSrData(), cacheutils::ValuesCache::get(), funct::NthDerivative< 0, X, F >::get(), funct::NthDerivative< n, X, F >::get(), funct::ConstPrimitive< X, F, true >::get(), HitPairGeneratorFromLayerPairForPhotonConversion::getCot(), TouchableToHistory::getFilteredView(), HoECalculator::getHoE(), WatcherStreamFileReader::getInputFile(), PhiSymmetryCalibration::getKfactors(), EcalTrivialConditionRetriever::getMappingFromConfiguration(), FWMagField::GetMaxFieldMag(), popcon::EcalSRPHandler::getNewObjects(), EcalMappingElectronicsHandler::getNewObjects(), popcon::EcalTPGFineGrainEBIdMapHandler::getNewObjects(), EcalClusterCrackCorrection::getValue(), CSCAnalogSignal::getValue(), EcalClusterLocalContCorrection::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(), DiskSectorBounds::inside(), Bounds::inside(), SimpleDiskBounds::inside(), PhotonConversionTrajectorySeedProducerFromSingleLegAlgo::inspectTrack(), ThreadSingleton< T, F >::instance(), funct::integral(), SiStripTemplate::interpolate(), SiPixelTemplate::interpolate(), LinearGridInterpolator3D::interpolate(), edm::isTransientEqual(), PerigeeConversions::jacobianPerigee2Curvilinear(), FWGUIValidatingTextEntry::keyPressedInPopup(), GaussianSumUtilities1D::lnPdf(), HcalDetDiagLaserMonitor::LoadDataset(), HcalDetDiagPedestalMonitor::LoadDataset(), FWFFLooper::loadDefaultGeometryFile(), MatacqProducer::loadOrbitOffset(), HcalPatternSource::loadPatternFile(), ClusterShapeHitFilter::loadPixelLimits(), HcalDetDiagLEDMonitor::LoadReference(), HcalDetDiagLaserMonitor::LoadReference(), HcalDetDiagPedestalMonitor::LoadReference(), stor::AlarmHandler::localDebug(), PSimHit::localDirection(), RadialStripTopology::localError(), StripCPEfromTemplate::localParameters(), StripCPE::localParameters(), StripCPEfromTrackAngle::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(), FastHisto2D::Normalize(), FastHisto::Normalize(), edm::AssociationMap< edm::OneToManyWithQualityGeneric< TrackingParticleCollection, edm::View< reco::Track >, double > >::numberOfAssociations(), LRHelpFunctions::obsFitIncluded(), CaloSamples::offsetTime(), HttpStorageMaker::open(), GsiFTPStorageMaker::open(), RFIOStorageMaker::open(), StormLcgGtStorageMaker::open(), XrdStorageMaker::open(), StormStorageMaker::open(), LocalStorageMaker::open(), DCacheStorageMaker::open(), BSpdfsFcn::operator()(), FreeFunctionSelector< T, f >::operator()(), CandMatcherBase< C1, C2 >::operator()(), funct::GaussLegendreIntegrator::operator()(), funct::GaussIntegrator::operator()(), edm::LogImportant::operator<<(), cscdqm::LogCout::operator<<(), funct::operator<<(), edm::LogWarning::operator<<(), reco::parser::operator<<(), edm::LogProblem::operator<<(), cms::operator<<(), edm::LogAbsolute::operator<<(), edm::LogInfo::operator<<(), edm::LogDebug_::operator<<(), operator<<(), edm::LogTrace_::operator<<(), edm::LogPrint::operator<<(), edm::LogVerbatim::operator<<(), edm::LogError::operator<<(), edm::service::ErrorLog::operator<<(), edm::edmmltest::LogWarningThatSuppressesLikeLogInfo::operator<<(), edm::LogSystem::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(), EcalTrigTowerConstituentsMapBuilder::parseTextMap(), PetrukhinFunc(), PFResolutionMapManager::PFResolutionMapManager(), CSCSegAlgoTC::phiAtZ(), CSCSegAlgoSK::phiAtZ(), SiPixelTemplateReco::PixelTempReco2D(), SiPixelTemplateSplit::PixelTempSplit(), cond::PayLoadInspector< DataT >::plot(), plotMaker(), TwoTrackMinimumDistance::pointsHelixHelix(), FWTriggerTableView::populateController(), FWRPZView::populateController(), FWFFService::postBeginJob(), VariableHelperService::postProcess(), InputTagDistributorService::preModule(), VariableHelperService::preModule(), fireworks::prepareTrack(), HcalRawDataMonitor::processEvent(), HcalRecHitMonitor::processEvent_rechit(), MCTrackMatcher::produce(), BeamSpotOnlineProducer::produce(), L1HLTJetsMatching::produce(), MatchedProbeMaker< T >::produce(), PFJetsMatchedToFilteredCaloJetsProducer::produce(), GenTrackMatcher::produce(), L1HLTTauMatching::produce(), L3TkMuonProducer::produce(), EcalTrivialConditionRetriever::produceEcalAlignmentEB(), EcalTrivialConditionRetriever::produceEcalAlignmentEE(), EcalTrivialConditionRetriever::produceEcalAlignmentES(), perftools::EdmEventSize::produceHistos(), gen::PtYDistributor::PtYDistributor(), EcalUncalibRecHitRecAnalFitAlgo< EBDataFrame >::pulseShapeFunction(), Histos::put(), SiPixelTemplate::qbin(), SiStripTemplate::qbin(), SiPixelTemplate::qbin_dist(), PixelRecoLineRZ::rAtZ(), edm::ValueMap< reco::MuonMETCorrectionData >::rawIndexOf(), hitfit::Defaults_Textrep::read_file(), TStorageFactoryFile::ReadBufferAsync(), DQMStore::readFile(), FWConfigurationManager::readFromFile(), 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(), TotemG4Hit::setPhiAtEntry(), FP420G4Hit::setPhiAtEntry(), BscG4Hit::setPhiAtEntry(), BaseParticlePropagator::setPropagationConditions(), FWMET3DProxyBuilder::Arrow::setScale(), CastorPulseShapes::Shape::setShapeBin(), HcalPulseShape::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(), JetPartonNamespace::ParametrizationJetParton::value(), root::helper::RootVarsAdapter< F, 2 >::value(), SiPixelTemplate::vavilov2_pars(), SiStripTemplate::vavilov2_pars(), SiStripTemplate::vavilov_pars(), SiPixelTemplate::vavilov_pars(), WatcherStreamFileReader::WatcherStreamFileReader(), ProvenanceDumper::work_(), sistrip::MeasureLA::write_report_text_ms(), edm::JobReport::JobReportImpl::writeInputFile(), edm::JobReport::JobReportImpl::writeOutputFile(), MSLayer::x0(), SiStripTemplate::xflcorr(), SiPixelTemplate::xflcorr(), SiStripTemplate::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.