CMS 3D CMS Logo

Functions | Variables

/afs/cern.ch/work/a/aaltunda/public/www/CMSSW_5_3_14/src/CalibCalorimetry/HcalStandardModules/src/HFLightCalRand.cc File Reference

#include <memory>
#include <string>
#include <iostream>
#include "TH1F.h"
#include "TH2F.h"
#include "TFile.h"
#include "math.h"
#include "TMath.h"
#include "TF1.h"
#include "CalibCalorimetry/HcalStandardModules/interface/HFLightCalRand.h"
#include "DataFormats/HcalDigi/interface/HcalDigiCollections.h"
#include "DataFormats/HcalRecHit/interface/HcalRecHitCollections.h"
#include "CalibFormats/HcalObjects/interface/HcalDbService.h"
#include "CalibFormats/HcalObjects/interface/HcalDbRecord.h"
#include "CondFormats/HcalObjects/interface/HcalQIEShape.h"
#include "CondFormats/HcalObjects/interface/HcalQIECoder.h"
#include "FWCore/Framework/interface/Event.h"
#include "FWCore/ParameterSet/interface/ParameterSet.h"
#include "FWCore/Framework/interface/EventSetup.h"
#include "FWCore/Framework/interface/ESHandle.h"

Go to the source code of this file.

Functions

Double_t Fit3Peak (Double_t *x, Double_t *par)
void HistSpec (TH1F *hist, Double_t &mean, Double_t &rms, Double_t range=4)

Variables

Int_t EventN = 0
Int_t NEvents
Int_t runNumb = 0

Function Documentation

Double_t Fit3Peak ( Double_t *  x,
Double_t *  par 
)

Definition at line 142 of file HFLightCalRand.cc.

References reco::ParticleMasses::k0, NEvents, diffTwoXMLs::r1, diffTwoXMLs::r2, and mathSSE::sqrt().

Referenced by HFLightCalRand::endJob().

                                              { 
// Spectra fit function: Pedestal Gaussian + asymmetric 1PE + 2PE +3PE peaks

  Double_t sum,xx,A0,C0,r0,sigma0,mean1,sigma1,A1,C1,r1,mean2,sigma2,A2,C2,r2,mean3,sigma3,A3,C3,r3;

  const Double_t k0=2.0,k1=1.6, k2=2.0;

  xx=x[0];
  sigma0 = par[2];
  A0 = 2*NEvents/(2+2*par[0]+par[0]*par[0]+par[0]*par[0]*par[0]/3);
  r0 = ((xx-par[1])/sigma0);
  C0 = 1/(sigma0* TMath::Exp(-k0*k0/2)/k0 +
          sigma0*sqrt(2*3.14159)*0.5*(1+TMath::Erf(k0/1.41421)));
  //sum = 1/(sqrt(2*3.14159)*par[2])*A0*TMath::Exp(-0.5*r0*r0);
  if(r0 < k0) sum = C0*A0*TMath::Exp(-0.5*r0*r0);
  else sum = C0*A0*TMath::Exp(0.5*k0*k0-k0*r0);

  mean1 = par[1]+par[3];
  //sigma1 = par[4];
  sigma1 = 1.547+0.125*par[3]+0.004042*par[3]*par[3];
  sigma1 = (sigma1+(9.1347e-3+3.845e-2*par[3])*par[4]*2.0)*par[2];
  A1 = A0*par[0];
  C1 = 1/(sigma1* TMath::Exp(-k1*k1/2)/k1 +
          sigma1*sqrt(2*3.14159)*0.5*(1+TMath::Erf(k1/1.41421)));
  r1 = ((xx-mean1)/sigma1);
  if(r1 < k1) sum += C1*A1*TMath::Exp(-0.5*r1*r1);
  else sum += C1*A1*TMath::Exp(0.5*k1*k1-k1*r1);

  mean2 = 2*par[3]+par[1];
  sigma2 = sqrt(2*sigma1*sigma1 - par[2]*par[2]);
  //A2 = A0*par[5]*par[0]*par[0]/2;
  A2 = A0*par[0]*par[0]/2;
  C2 = 1/(sigma2* TMath::Exp(-k2*k2/2)/k2 +
          sigma2*sqrt(2*3.14159)*0.5*(1+TMath::Erf(k2/1.41421)));
  r2 = ((xx-mean2)/sigma2);
  if(r2 < k2) sum += C2*A2*TMath::Exp(-0.5*r2*r2);
  else sum += C2*A2*TMath::Exp(0.5*k2*k2-k2*r2);

  mean3 = 3*par[3]+par[1];
  sigma3 = sqrt(3*sigma1*sigma1 - 2*par[2]*par[2]);
  A3 = A0*par[0]*par[0]*par[0]/6;
  C3 = 1/(sigma3*sqrt(2*3.14159));
  r3 = ((xx-mean3)/sigma3);
  sum += C3*A3*TMath::Exp(-0.5*r3*r3);

  return sum;
}
void HistSpec ( TH1F *  hist,
Double_t &  mean,
Double_t &  rms,
Double_t  range = 4 
)

Definition at line 126 of file HFLightCalRand.cc.

Referenced by HFLightCalRand::endJob().

                                                                           {
  Double_t xmin,xmax;
  mean=hist->GetMean();
  rms=hist->GetRMS();
  xmin=hist->GetXaxis()->GetXmin();
  xmax=hist->GetXaxis()->GetXmax();
  hist->SetAxisRange(mean-range*rms-100,mean+range*rms+100);
  mean=hist->GetMean();
  rms=hist->GetRMS();
  hist->SetAxisRange(mean-range*rms-100,mean+range*rms+100);
  mean=hist->GetMean();
  rms=hist->GetRMS();
  hist->SetAxisRange(xmin,xmax);
  return;
}

Variable Documentation

Int_t EventN = 0

Definition at line 36 of file HFLightCalRand.cc.

Referenced by HFLightCalRand::analyze(), and HFLightCalRand::endJob().

Int_t NEvents

Definition at line 36 of file HFLightCalRand.cc.

Referenced by HFLightCalRand::endJob(), and Fit3Peak().

Int_t runNumb = 0

Definition at line 36 of file HFLightCalRand.cc.

Referenced by HFLightCalRand::analyze(), and HFLightCalRand::endJob().