![]() |
AliPhysics
c69cd47 (c69cd47)
|
#include <AliHFPtSpectrum.h>
Public Member Functions | |
AliHFPtSpectrum (const char *name="AliHFPtSpectrum", const char *title="HF feed down correction class", Int_t option=1) | |
Constructor. More... | |
AliHFPtSpectrum (const AliHFPtSpectrum &rhs) | |
Copy constructor. More... | |
AliHFPtSpectrum & | operator= (const AliHFPtSpectrum &source) |
Assignment operator. More... | |
virtual | ~AliHFPtSpectrum () |
Destructor. More... | |
void | SetMCptSpectra (TH1D *hDirect, TH1D *hFeedDown) |
void | SetFeedDownMCptSpectra (TH1D *hFeedDown) |
Set the theoretical feeddown pt spectrum. More... | |
void | SetMCptDistributionsBounds (TH1D *hDirectMax, TH1D *hDirectMin, TH1D *hFeedDownMax, TH1D *hFeedDownMin) |
Set the theoretical direct & feeddown pt spectrum upper and lower bounds. More... | |
void | SetFeedDownMCptDistributionsBounds (TH1D *hFeedDownMax, TH1D *hFeedDownMin) |
Set the theoretical feeddown pt spectrum upper and lower bounds. More... | |
void | SetDirectAccEffCorrection (TH1D *hDirectEff) |
Set the acceptance and efficiency corrections for direct. More... | |
void | SetAccEffCorrection (TH1D *hDirectEff, TH1D *hFeedDownEff) |
Set the acceptance and efficiency corrections for direct & feeddown. More... | |
void | SetReconstructedSpectrum (TH1D *hRec) |
Set the reconstructed spectrum. More... | |
void | SetReconstructedSpectrumSystematics (TGraphAsymmErrors *gRec) |
void | SetFeedDownCalculationOption (Int_t option) |
Set the calculation option flag for feed-down correction: 0=none, 1=fc , 2=Nb. More... | |
void | SetComputeAsymmetricUncertainties (Bool_t flag) |
Set if the calculation has to consider asymmetric uncertaInt_ties or not. More... | |
void | SetIsParticlePlusAntiParticleYield (Bool_t flag) |
Set if the yield is for particle plus anti-particle or not. More... | |
void | SetIsEventPlaneAnalysis (Bool_t flag) |
void | SetfIsStatUncEff (Bool_t flag) |
void | SetComputeElossHypothesis (Bool_t flag) |
Set if the calculation has to consider Ratio(c/b eloss) hypothesis. More... | |
void | SetLuminosity (Double_t luminosity, Double_t unc) |
Set the luminosity and its uncertainty. More... | |
void | SetTriggerEfficiency (Double_t efficiency, Double_t unc) |
Set the trigger efficiency and its uncertainty. More... | |
void | SetAccEffPercentageUncertainty (Double_t globalEffUnc, Double_t globalBCEffRatioUnc) |
Set global acceptance x efficiency correction uncertainty (in percentages) More... | |
void | SetUsePtDependentEffUncertainty (Bool_t flag) |
Setter to switch on the pt dependent efficiency correction uncertainty (feed-down calculation) More... | |
void | SetSystematicUncertainty (AliHFSystErr *syst) |
void | SetNormalization (Double_t normalization) |
Set the normalization factors. More... | |
void | SetNormalization (Int_t nevents, Double_t sigma) |
void | SetNormalization (Int_t nevents, Double_t sigma, Double_t sigmaunc) |
void | SetTabParameter (Double_t tabvalue, Double_t uncertainty) |
Set the Tab parameter and its uncertainty. More... | |
void | SetCollisionType (Int_t ct) |
TH1D * | GetDirectTheoreticalSpectrum () const |
TH1D * | GetDirectTheoreticalUpperLimitSpectrum () const |
TH1D * | GetDirectTheoreticalLowerLimitSpectrum () const |
TH1D * | GetFeedDownTheoreticalSpectrum () const |
TH1D * | GetFeedDownTheoreticalUpperLimitSpectrum () const |
TH1D * | GetFeedDownTheoreticalLowerLimitSpectrum () const |
TH1D * | GetDirectAccEffCorrection () const |
Return the acceptance and efficiency corrections (rebinned if needed) More... | |
TH1D * | GetFeedDownAccEffCorrection () const |
Bool_t | IsElossHypothesisCalculated () |
Return whether the Ratio(c/b eloss) hypothesis has been considered. More... | |
TGraphAsymmErrors * | GetFeedDownCorrectionFcExtreme () const |
Return the TGraphAsymmErrors of the feed-down correction (extreme systematics) More... | |
TGraphAsymmErrors * | GetFeedDownCorrectionFcConservative () const |
Return the TGraphAsymmErrors of the feed-down correction (conservative systematics) More... | |
TH1D * | GetHistoFeedDownCorrectionFc () const |
Return the histogram of the feed-down correction. More... | |
TH1D * | GetHistoUpperLimitFeedDownCorrectionFc () const |
Return the histograms of the feed-down correction bounds. More... | |
TH1D * | GetHistoLowerLimitFeedDownCorrectionFc () const |
TH2D * | GetHistoFeedDownCorrectionFcVsEloss () const |
Return the histogram of the feed-down correction times the Ratio(c/b eloss) More... | |
TGraphAsymmErrors * | GetFeedDownCorrectedSpectrum () const |
Return the TGraphAsymmErrors of the yield after feed-down correction (systematics but feed-down) More... | |
TGraphAsymmErrors * | GetFeedDownCorrectedSpectrumExtreme () const |
Return the TGraphAsymmErrors of the yield after feed-down correction (feed-down extreme systematics) More... | |
TGraphAsymmErrors * | GetFeedDownCorrectedSpectrumConservative () const |
Return the TGraphAsymmErrors of the yield after feed-down correction (feed-down conservative systematics) More... | |
TH1D * | GetHistoFeedDownCorrectedSpectrum () const |
Return the histogram of the yield after feed-down correction. More... | |
TH1D * | GetHistoUpperLimitFeedDownCorrectedSpectrum () const |
Return the histogram of the yield after feed-down correction bounds. More... | |
TH1D * | GetHistoLowerLimitFeedDownCorrectedSpectrum () const |
TH2D * | GetHistoFeedDownCorrectedSpectrumVsEloss () const |
Return the histogram of the yield after feed-down correction vs the Ratio(c/b eloss) More... | |
TGraphAsymmErrors * | GetCrossSectionFromYieldSpectrum () const |
Return the equivalent invariant cross-section TGraphAsymmErrors (systematics but feed-down) More... | |
TGraphAsymmErrors * | GetCrossSectionFromYieldSpectrumExtreme () const |
Return the equivalent invariant cross-section TGraphAsymmErrors (feed-down extreme systematics) More... | |
TGraphAsymmErrors * | GetCrossSectionFromYieldSpectrumConservative () const |
Return the equivalent invariant cross-section TGraphAsymmErrors (feed-down conservative systematics) More... | |
TH1D * | GetHistoCrossSectionFromYieldSpectrum () const |
Return the equivalent invariant cross-section histogram. More... | |
TH1D * | GetHistoUpperLimitCrossSectionFromYieldSpectrum () const |
Return the equivalent invariant cross-section histogram bounds. More... | |
TH1D * | GetHistoLowerLimitCrossSectionFromYieldSpectrum () const |
TH1D * | GetHistoCrossSectionDataSystematics () const |
Return the cross section systematics from data systematics. More... | |
TH2D * | GetHistoCrossSectionFromYieldSpectrumVsEloss () const |
TNtuple * | GetNtupleCrossSectionVsEloss () |
Return the ntuple of the calculation vs the Ratio(c/b eloss) More... | |
TH1D * | GetDirectStatEffUncOnSigma () const |
TH1D * | GetFeedDownStatEffUncOnSigma () const |
TH1D * | GetDirectStatEffUncOnFc () const |
Histograms to keep track of the influence of the efficiencies statistical uncertainty on the feed-down correction factor. More... | |
TH1D * | GetFeedDownStatEffUncOnFc () const |
void | ComputeHFPtSpectrum (Double_t deltaY=1.0, Double_t branchingRatioC=1.0, Double_t branchingRatioBintoFinalDecay=1.0) |
void | ComputeSystUncertainties (Bool_t combineFeedDown) |
void | DrawSpectrum (TGraphAsymmErrors *gPrediction) |
Drawing the corrected spectrum comparing to theoretical prediction. More... | |
void | EstimateAndSetDirectEfficiencyRecoBin (TH1D *hSimu, TH1D *hReco) |
void | EstimateAndSetFeedDownEfficiencyRecoBin (TH1D *hSimu, TH1D *hReco) |
TH1D * | ReweightHisto (TH1D *hToReweight, TH1D *hReference) |
TH1D * | ReweightRecHisto (TH1D *hRecToReweight, TH1D *hMCToReweight, TH1D *hMCReference) |
to reweight the reco-histos: hRecToReweight is reweighted as hReference/hMCToReweight More... | |
Int_t | FindTH2YBin (TH2D *histo, Float_t yvalue) |
Functionality to find the y-axis bin of a TH2 for a given y-value. More... | |
Protected Member Functions | |
Bool_t | Initialize () |
Initialization. More... | |
void | CalculateCorrectedSpectrumNoFeedDown () |
void | CalculateFeedDownCorrectionFc () |
Compute the feed-down correction via fc-method. More... | |
void | CalculateFeedDownCorrectedSpectrumFc () |
Correct the yield for feed-down correction via fc-method. More... | |
void | CalculateFeedDownCorrectedSpectrumNb (Double_t deltaY, Double_t branchingRatioBintoFinalDecay) |
Correct the yield for feed-down correction via Nb-method. More... | |
Double_t | CalculateEfficiencyPtDepedentUncertainty (Double_t pt, Bool_t useOnlyCutVar) |
Calculate the efficiency pt-dependent uncertainty. More... | |
Bool_t | CheckHistosConsistency (TH1D *h1, TH1D *h2) |
Check histograms consistency function. More... | |
TH1D * | RebinTheoreticalSpectra (TH1D *hTheory, const char *name) |
Function to rebin the theoretical spectra in the data-reconstructed spectra binning. More... | |
TH1D * | EstimateEfficiencyRecoBin (TH1D *hSimu, TH1D *hReco, const char *name) |
Function to estimate the efficiency in the data-reconstructed spectra binning. More... | |
void | ResetStatUncEff () |
Reset stat unc on the efficiencies. More... | |
Protected Attributes | |
TH1D * | fhDirectMCpt |
TH1D * | fhFeedDownMCpt |
Input MC c–>D spectra. More... | |
TH1D * | fhDirectMCptMax |
Input MC b–>D spectra. More... | |
TH1D * | fhDirectMCptMin |
Input MC maximum c–>D spectra. More... | |
TH1D * | fhFeedDownMCptMax |
Input MC minimum c–>D spectra. More... | |
TH1D * | fhFeedDownMCptMin |
Input MC maximum b–>D spectra. More... | |
TH1D * | fhDirectEffpt |
Input MC minimum b–>D spectra. More... | |
TH1D * | fhFeedDownEffpt |
c–>D Acceptance and efficiency correction More... | |
TH1D * | fhRECpt |
b–>D Acceptance and efficiency correction More... | |
TGraphAsymmErrors * | fgRECSystematics |
all reconstructed D More... | |
Int_t | fNevts |
all reconstructed D Systematic uncertainties More... | |
Double_t | fLuminosity [2] |
nb of analyzed events More... | |
Double_t | fTrigEfficiency [2] |
analyzed luminosity & uncertainty More... | |
Double_t | fGlobalEfficiencyUncertainties [2] |
trigger efficiency & uncertainty More... | |
Bool_t | fGlobalEfficiencyPtDependent |
uncertainties on the efficiency [0]=c, b, [1]=b/c More... | |
Double_t | fTab [2] |
use a pt-dependent efficiency uncertainty (Nb method unc.) More... | |
AliHFSystErr * | fSystematics |
Tab parameter and its uncertainty. More... | |
TH1D * | fhFc |
Systematic uncertainy on the raw yields. More... | |
TH1D * | fhFcMax |
Correction histo fc = 1 / ( 1 + (eff_b/eff_c)*(N_b/N_c) ) More... | |
TH1D * | fhFcMin |
Maximum fc histo. More... | |
TH2D * | fhFcRcb |
Minimum fc histo. More... | |
TGraphAsymmErrors * | fgFcExtreme |
Correction histo fc vs the Ratio(c/b eloss) More... | |
TGraphAsymmErrors * | fgFcConservative |
Extreme correction as TGraphAsymmErrors. More... | |
TH1D * | fhYieldCorr |
Extreme correction as TGraphAsymmErrors. More... | |
TH1D * | fhYieldCorrMax |
Corrected yield (stat unc. only) More... | |
TH1D * | fhYieldCorrMin |
Maximum corrected yield. More... | |
TH2D * | fhYieldCorrRcb |
Minimum corrected yield. More... | |
TGraphAsymmErrors * | fgYieldCorr |
Corrected yield (stat unc. only) vs the Ratio(c/b eloss) More... | |
TGraphAsymmErrors * | fgYieldCorrExtreme |
Corrected yield as TGraphAsymmErrors (syst but feed-down) More... | |
TGraphAsymmErrors * | fgYieldCorrConservative |
Extreme corrected yield as TGraphAsymmErrors (syst from feed-down) More... | |
TH1D * | fhSigmaCorr |
Conservative corrected yield as TGraphAsymmErrors (syst from feed-down) More... | |
TH1D * | fhSigmaCorrMax |
Corrected cross-section (stat unc. only) More... | |
TH1D * | fhSigmaCorrMin |
Maximum corrected cross-section. More... | |
TH1D * | fhSigmaCorrDataSyst |
Minimum corrected cross-section. More... | |
TH2D * | fhSigmaCorrRcb |
Corrected cross-section (syst. unc. from data only) More... | |
TGraphAsymmErrors * | fgSigmaCorr |
Corrected cross-section (stat unc. only) vs the Ratio(c/b eloss) More... | |
TGraphAsymmErrors * | fgSigmaCorrExtreme |
Corrected cross-section as TGraphAsymmErrors (syst but feed-down) More... | |
TGraphAsymmErrors * | fgSigmaCorrConservative |
Extreme corrected cross-section as TGraphAsymmErrors (syst from feed-down) More... | |
TNtuple * | fnSigma |
Conservative corrected cross-section as TGraphAsymmErrors (syst from feed-down) More... | |
TNtuple * | fnHypothesis |
Ntuple of the calculation vs the Ratio(c/b eloss) More... | |
Int_t | fCollisionType |
Ntuple of the calculation vs the Ratio(c/b eloss) More... | |
Int_t | fFeedDownOption |
0=pp, 1=Pb-Pb, 2=p-Pb More... | |
Bool_t | fAsymUncertainties |
feed-down correction flag: 0=none, 1=fc, 2=Nb More... | |
Bool_t | fPbPbElossHypothesis |
flag: asymmetric uncertainties are (1) or not (0) considered More... | |
Bool_t | fIsStatUncEff |
flag: whether to do estimates vs Ratio(c/b eloss) hypothesis More... | |
Int_t | fParticleAntiParticle |
flag : consider (1) or not (0) the stat unc on the efficiencies More... | |
Bool_t | fIsEventPlane |
1: only one sign, 2: yield is for particle+anti-particle More... | |
Int_t | fnPtBins |
flag : when the analysis is done for In/Out of plane, divide the B-prediction by two More... | |
Double_t * | fPtBinLimits |
number of pt bins More... | |
Double_t * | fPtBinWidths |
TH1D * | fhStatUncEffcSigma |
TH1D * | fhStatUncEffbSigma |
Uncertainty on the cross-section due to the prompt efficiency statistical uncertainty. More... | |
TH1D * | fhStatUncEffcFD |
Uncertainty on the cross-section due to the feed-down efficiency statistical uncertainty. More... | |
TH1D * | fhStatUncEffbFD |
Uncertainty on the feed-down correction due to the prompt efficiency statistical uncertainty. More... | |
Definition at line 40 of file AliHFPtSpectrum.h.
AliHFPtSpectrum::AliHFPtSpectrum | ( | const char * | name = "AliHFPtSpectrum" , |
const char * | title = "HF feed down correction class" , |
||
Int_t | option = 1 |
||
) |
AliHFPtSpectrum::AliHFPtSpectrum | ( | const AliHFPtSpectrum & | rhs | ) |
|
virtual |
|
protected |
Basic functions
Correct the yield for feed-down correction via fc-method
Compute the corrected spectrum with no feed-down correction
Definition at line 1039 of file AliHFPtSpectrum.cxx.
Referenced by ComputeHFPtSpectrum().
|
protected |
Calculate the efficiency pt-dependent uncertainty.
Function computing the pt-dependent efficiency uncertainty to be used in the Nb feed-down correction uncertainty determination (both tracking and cut variation uncertainties are considered)
Definition at line 1626 of file AliHFPtSpectrum.cxx.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), and CalculateFeedDownCorrectionFc().
|
protected |
Correct the yield for feed-down correction via fc-method.
Compute the feed-down corrected spectrum if feed-down correction is done via fc factor (bin by bin) physics = reco * fc / bin-width
uncertainty: (stat) delta_physics = physics * sqrt ( (delta_reco/reco)^2 ) (syst but feed-down) delta_physics = physics * sqrt ( (delta_reco_syst/reco)^2 ) (feed-down syst) delta_physics = physics * sqrt ( (delta_fc/fc)^2 )
( Calculation done bin by bin )
In addition, in HIC the feed-down correction varies with an energy loss hypothesis: Raa(c–>D) / Raa(b–>D) = Rcb
Definition at line 1285 of file AliHFPtSpectrum.cxx.
Referenced by ComputeHFPtSpectrum().
|
protected |
Correct the yield for feed-down correction via Nb-method.
Compute the feed-down corrected spectrum if feed-down correction is done via Nb (bin by bin) physics = [ reco - (lumi * delta_y * BR_b * eff_trig * eff_b * Nb_th) ] / bin-width
uncertainty: (stat) delta_physics = sqrt ( (delta_reco)^2 ) / bin-width (syst but feed-down) delta_physics = sqrt ( (delta_reco_syst)^2 ) / bin-width (feed-down syst) delta_physics = sqrt ( (k*delta_lumi/lumi)^2 + (k*delta_eff_trig/eff_trig)^2
In addition, in HIC the feed-down correction varies with an energy loss hypothesis: Raa(b–>D) = Rb physics = [ reco - ( Tab * Nevt * delta_y * BR_b * eff_trig * eff_b * Nb_th * Rb ) ] / bin-width
Definition at line 1410 of file AliHFPtSpectrum.cxx.
Referenced by ComputeHFPtSpectrum().
|
protected |
Compute the feed-down correction via fc-method.
Compute fc factor and its uncertainties bin by bin fc = 1 / ( 1 + (eff_b/eff_c)*(N_b/N_c) )
uncertainties: (conservative) combine the upper/lower N_b & N_c predictions together (extreme) combine the upper N_b predictions with the lower N_c predictions & viceversa systematic uncertainty on the acceptance x efficiency b/c ratio are included
In addition, in HIC the feed-down correction varies with an energy loss hypothesis: Raa(c–>D) / Raa(b–>D) = Rcb fc (Rcb) = ( 1. / ( 1 + (eff_b/eff_c)*(N_b/N_c)* (1/Rcb) ) );
Definition at line 1069 of file AliHFPtSpectrum.cxx.
Referenced by ComputeHFPtSpectrum().
|
protected |
Check histograms consistency function.
Check the histograms consistency (bins, limits)
Definition at line 1005 of file AliHFPtSpectrum.cxx.
Referenced by Initialize(), ReweightHisto(), ReweightRecHisto(), SetAccEffCorrection(), SetFeedDownMCptDistributionsBounds(), SetMCptDistributionsBounds(), and SetMCptSpectra().
void AliHFPtSpectrum::ComputeHFPtSpectrum | ( | Double_t | deltaY = 1.0 , |
Double_t | branchingRatioC = 1.0 , |
||
Double_t | branchingRatioBintoFinalDecay = 1.0 |
||
) |
Main function: Compute the invariant cross-section from the yield (correct it) variables : analysed delta_y, BR for the final correction, BR b –> decay (relative to the input theoretical prediction)
Main function to compute the corrected cross-section: variables : analysed delta_y, BR for the final correction, BR b –> D –> decay (relative to the input theoretical prediction)
Sigma = ( 1. / (lumi * delta_y * BR_c * ParticleAntiPartFactor * eff_trig * eff_c ) ) * spectra (corrected for feed-down)
Uncertainties: (stat) delta_sigma = sigma * sqrt ( (delta_spectra/spectra)^2 ) (syst but feed-down) delta_sigma = sigma * sqrt ( (delta_spectra_syst/spectra)^2 + (delta_lumi/lumi)^2 + (delta_eff_trig/eff_trig)^2 + (delta_eff/eff)^2 ) (feed-down syst) delta_sigma = sigma * sqrt ( (delta_spectra_fd/spectra_fd)^2 )
In HIC the feed-down correction varies with an energy loss hypothesis: Raa(c–>D) / Raa(b–>D) for the "fc" method, Raa(b–>D) for the "Nb" method (see exact formulas in the functions)
Definition at line 588 of file AliHFPtSpectrum.cxx.
Referenced by HFPtSpectrum().
void AliHFPtSpectrum::ComputeSystUncertainties | ( | Bool_t | combineFeedDown | ) |
Compute the systematic uncertainties taking as input the AliHFSystErr uncertainties
Function that re-calculates the global systematic uncertainties by calling the class AliHFSystErr and combining those (in quadrature) with the feed-down subtraction uncertainties
Definition at line 1643 of file AliHFPtSpectrum.cxx.
Referenced by HFPtSpectrum().
void AliHFPtSpectrum::DrawSpectrum | ( | TGraphAsymmErrors * | gPrediction | ) |
Drawing the corrected spectrum comparing to theoretical prediction.
Example method to draw the corrected spectrum & the theoretical prediction
Definition at line 1708 of file AliHFPtSpectrum.cxx.
void AliHFPtSpectrum::EstimateAndSetDirectEfficiencyRecoBin | ( | TH1D * | hSimu, |
TH1D * | hReco | ||
) |
Basic functions
Function that computes the Direct acceptance and efficiency correction based on the simulated and reconstructed spectra and using the reconstructed spectra bin width
eff = reco/sim ; err_eff = sqrt( eff*(1-eff) )/ sqrt( sim )
Definition at line 892 of file AliHFPtSpectrum.cxx.
void AliHFPtSpectrum::EstimateAndSetFeedDownEfficiencyRecoBin | ( | TH1D * | hSimu, |
TH1D * | hReco | ||
) |
Function that computes the Feed-Down acceptance and efficiency correction based on the simulated and reconstructed spectra and using the reconstructed spectra bin width
eff = reco/sim ; err_eff = sqrt( eff*(1-eff) )/ sqrt( sim )
Definition at line 912 of file AliHFPtSpectrum.cxx.
|
protected |
Function to estimate the efficiency in the data-reconstructed spectra binning.
Function that computes the acceptance and efficiency correction based on the simulated and reconstructed spectra and using the reconstructed spectra bin width
eff = reco/sim ; err_eff = sqrt( eff*(1-eff) )/ sqrt( sim )
Definition at line 833 of file AliHFPtSpectrum.cxx.
Referenced by EstimateAndSetDirectEfficiencyRecoBin(), and EstimateAndSetFeedDownEfficiencyRecoBin().
Int_t AliHFPtSpectrum::FindTH2YBin | ( | TH2D * | histo, |
Float_t | yvalue | ||
) |
Functionality to find the y-axis bin of a TH2 for a given y-value.
Function to find the y-axis bin of a TH2 for a given y-value
Definition at line 1829 of file AliHFPtSpectrum.cxx.
Referenced by CalculateFeedDownCorrectedSpectrumFc(), and HFPtSpectrum().
|
inline |
Return the equivalent invariant cross-section TGraphAsymmErrors (systematics but feed-down)
Definition at line 170 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the equivalent invariant cross-section TGraphAsymmErrors (feed-down conservative systematics)
Definition at line 174 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the equivalent invariant cross-section TGraphAsymmErrors (feed-down extreme systematics)
Definition at line 172 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the acceptance and efficiency corrections (rebinned if needed)
Definition at line 141 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Histograms to keep track of the influence of the efficiencies statistical uncertainty on the feed-down correction factor.
Definition at line 194 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Histograms to keep track of the influence of the efficiencies statistical uncertainty on the cross-section
Definition at line 191 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 136 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Getters
Return the theoretical predictions used for the calculation (rebinned if needed)
Definition at line 134 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 135 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 142 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the TGraphAsymmErrors of the yield after feed-down correction (systematics but feed-down)
Definition at line 157 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the TGraphAsymmErrors of the yield after feed-down correction (feed-down conservative systematics)
Definition at line 161 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the TGraphAsymmErrors of the yield after feed-down correction (feed-down extreme systematics)
Definition at line 159 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the TGraphAsymmErrors of the feed-down correction (conservative systematics)
Definition at line 148 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the TGraphAsymmErrors of the feed-down correction (extreme systematics)
Definition at line 146 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 195 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 192 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 139 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 137 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 138 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the cross section systematics from data systematics.
Definition at line 181 of file AliHFPtSpectrum.h.
|
inline |
Return the equivalent invariant cross-section histogram.
Definition at line 176 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
PbPb special calculations Return the equivalent invariant cross-section histogram vs the Ratio(c/b eloss)
Definition at line 185 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the histogram of the yield after feed-down correction.
Definition at line 163 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the histogram of the yield after feed-down correction vs the Ratio(c/b eloss)
Definition at line 168 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the histogram of the feed-down correction.
Definition at line 150 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the histogram of the feed-down correction times the Ratio(c/b eloss)
Definition at line 155 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 179 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 166 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 153 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the equivalent invariant cross-section histogram bounds.
Definition at line 178 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the histogram of the yield after feed-down correction bounds.
Definition at line 165 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the histograms of the feed-down correction bounds.
Definition at line 152 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Return the ntuple of the calculation vs the Ratio(c/b eloss)
Definition at line 187 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
protected |
Initialization.
Initialization of the variables (histograms)
Definition at line 932 of file AliHFPtSpectrum.cxx.
Referenced by ComputeHFPtSpectrum().
|
inline |
Return whether the Ratio(c/b eloss) hypothesis has been considered.
Definition at line 144 of file AliHFPtSpectrum.h.
AliHFPtSpectrum & AliHFPtSpectrum::operator= | ( | const AliHFPtSpectrum & | source | ) |
|
protected |
Function to rebin the theoretical spectra in the data-reconstructed spectra binning.
Function to rebin the theoretical spectrum with respect to the real-data reconstructed spectrum binning
Definition at line 327 of file AliHFPtSpectrum.cxx.
Referenced by SetFeedDownMCptDistributionsBounds(), SetFeedDownMCptSpectra(), SetMCptDistributionsBounds(), and SetMCptSpectra().
|
protected |
Reset stat unc on the efficiencies.
Definition at line 1851 of file AliHFPtSpectrum.cxx.
Referenced by ComputeHFPtSpectrum().
TH1D * AliHFPtSpectrum::ReweightHisto | ( | TH1D * | hToReweight, |
TH1D * | hReference | ||
) |
Functions to reweight histograms for testing purposes: to reweight the simulation: hToReweight is reweighted as hReference/hToReweight
Function to reweight histograms for testing purposes: This function takes the histo hToReweight and reweights it (its pt shape) with respect to hReference
Definition at line 1747 of file AliHFPtSpectrum.cxx.
TH1D * AliHFPtSpectrum::ReweightRecHisto | ( | TH1D * | hRecToReweight, |
TH1D * | hMCToReweight, | ||
TH1D * | hMCReference | ||
) |
to reweight the reco-histos: hRecToReweight is reweighted as hReference/hMCToReweight
Function to reweight histograms for testing purposes: This function takes the histo hToReweight and reweights it (its pt shape) with respect to hReference /hMCToReweight
Definition at line 1784 of file AliHFPtSpectrum.cxx.
void AliHFPtSpectrum::SetAccEffCorrection | ( | TH1D * | hDirectEff, |
TH1D * | hFeedDownEff | ||
) |
Set the acceptance and efficiency corrections for direct & feeddown.
Set the Acceptance and Efficiency corrections both for direct and feed-down contributions
Definition at line 513 of file AliHFPtSpectrum.cxx.
Referenced by HFPtSpectrum().
|
inline |
Set global acceptance x efficiency correction uncertainty (in percentages)
Definition at line 95 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 126 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Set if the calculation has to consider asymmetric uncertaInt_ties or not.
Definition at line 75 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Set if the calculation has to consider Ratio(c/b eloss) hypothesis.
Definition at line 85 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
void AliHFPtSpectrum::SetDirectAccEffCorrection | ( | TH1D * | hDirectEff | ) |
Set the acceptance and efficiency corrections for direct.
Set the Acceptance and Efficiency corrections for the direct contribution
Definition at line 497 of file AliHFPtSpectrum.cxx.
|
inline |
Set the calculation option flag for feed-down correction: 0=none, 1=fc , 2=Nb.
Definition at line 73 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
void AliHFPtSpectrum::SetFeedDownMCptDistributionsBounds | ( | TH1D * | hFeedDownMax, |
TH1D * | hFeedDownMin | ||
) |
Set the theoretical feeddown pt spectrum upper and lower bounds.
Set the maximum and minimum MonteCarlo or Theoretical spectra for feed-down contributions used in case uncertainties are asymmetric and can not be on the "basic histogram"
Definition at line 466 of file AliHFPtSpectrum.cxx.
Referenced by HFPtSpectrum().
void AliHFPtSpectrum::SetFeedDownMCptSpectra | ( | TH1D * | hFeedDown | ) |
Set the theoretical feeddown pt spectrum.
Set the MonteCarlo or Theoretical spectra for feed-down contribution
Definition at line 409 of file AliHFPtSpectrum.cxx.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 83 of file AliHFPtSpectrum.h.
|
inline |
Definition at line 81 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Set if the yield is for particle plus anti-particle or not.
Definition at line 77 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Set the luminosity and its uncertainty.
Definition at line 87 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
void AliHFPtSpectrum::SetMCptDistributionsBounds | ( | TH1D * | hDirectMax, |
TH1D * | hDirectMin, | ||
TH1D * | hFeedDownMax, | ||
TH1D * | hFeedDownMin | ||
) |
Set the theoretical direct & feeddown pt spectrum upper and lower bounds.
Set the maximum and minimum MonteCarlo or Theoretical spectra both for direct and feed-down contributions used in case uncertainties are asymmetric and ca not be on the "basic histograms"
Definition at line 429 of file AliHFPtSpectrum.cxx.
Referenced by HFPtSpectrum().
void AliHFPtSpectrum::SetMCptSpectra | ( | TH1D * | hDirect, |
TH1D * | hFeedDown | ||
) |
Setters
Set the theoretical direct & feeddown pt spectrum
Set the MonteCarlo or Theoretical spectra both for direct and feed-down contributions
Definition at line 380 of file AliHFPtSpectrum.cxx.
Referenced by HFPtSpectrum().
|
inline |
Set the normalization factors.
Definition at line 108 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Definition at line 111 of file AliHFPtSpectrum.h.
|
inline |
Definition at line 115 of file AliHFPtSpectrum.h.
void AliHFPtSpectrum::SetReconstructedSpectrum | ( | TH1D * | hRec | ) |
Set the reconstructed spectrum.
Set the reconstructed spectrum
Definition at line 538 of file AliHFPtSpectrum.cxx.
Referenced by HFPtSpectrum().
void AliHFPtSpectrum::SetReconstructedSpectrumSystematics | ( | TGraphAsymmErrors * | gRec | ) |
Set the reconstructed spectrum (uncorrected yield) systematic uncertainties
Definition at line 568 of file AliHFPtSpectrum.cxx.
|
inline |
Definition at line 103 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Set the Tab parameter and its uncertainty.
Definition at line 122 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Set the trigger efficiency and its uncertainty.
Definition at line 91 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
inline |
Setter to switch on the pt dependent efficiency correction uncertainty (feed-down calculation)
Definition at line 100 of file AliHFPtSpectrum.h.
Referenced by HFPtSpectrum().
|
protected |
feed-down correction flag: 0=none, 1=fc, 2=Nb
Definition at line 311 of file AliHFPtSpectrum.h.
Referenced by CalculateCorrectedSpectrumNoFeedDown(), CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), ComputeHFPtSpectrum(), Initialize(), operator=(), and SetComputeAsymmetricUncertainties().
|
protected |
Ntuple of the calculation vs the Ratio(c/b eloss)
Definition at line 308 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), operator=(), and SetCollisionType().
|
protected |
0=pp, 1=Pb-Pb, 2=p-Pb
Definition at line 310 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), ComputeSystUncertainties(), Initialize(), operator=(), and SetFeedDownCalculationOption().
|
protected |
Extreme correction as TGraphAsymmErrors.
Definition at line 289 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), GetFeedDownCorrectionFcConservative(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Correction histo fc vs the Ratio(c/b eloss)
Definition at line 288 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectionFc(), GetFeedDownCorrectionFcExtreme(), operator=(), and ~AliHFPtSpectrum().
|
protected |
uncertainties on the efficiency [0]=c, b, [1]=b/c
Definition at line 276 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), ComputeHFPtSpectrum(), operator=(), and SetUsePtDependentEffUncertainty().
|
protected |
trigger efficiency & uncertainty
Definition at line 275 of file AliHFPtSpectrum.h.
Referenced by AliHFPtSpectrum(), CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), ComputeHFPtSpectrum(), operator=(), and SetAccEffPercentageUncertainty().
|
protected |
all reconstructed D
Definition at line 269 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), operator=(), SetReconstructedSpectrumSystematics(), and ~AliHFPtSpectrum().
|
protected |
Corrected cross-section (stat unc. only) vs the Ratio(c/b eloss)
Definition at line 302 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), ComputeSystUncertainties(), DrawSpectrum(), GetCrossSectionFromYieldSpectrum(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Extreme corrected cross-section as TGraphAsymmErrors (syst from feed-down)
Definition at line 304 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), ComputeSystUncertainties(), GetCrossSectionFromYieldSpectrumConservative(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Corrected cross-section as TGraphAsymmErrors (syst but feed-down)
Definition at line 303 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), GetCrossSectionFromYieldSpectrumExtreme(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Corrected yield (stat unc. only) vs the Ratio(c/b eloss)
Definition at line 294 of file AliHFPtSpectrum.h.
Referenced by CalculateCorrectedSpectrumNoFeedDown(), CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), ComputeHFPtSpectrum(), GetFeedDownCorrectedSpectrum(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Extreme corrected yield as TGraphAsymmErrors (syst from feed-down)
Definition at line 296 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), ComputeHFPtSpectrum(), GetFeedDownCorrectedSpectrumConservative(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Corrected yield as TGraphAsymmErrors (syst but feed-down)
Definition at line 295 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), ComputeHFPtSpectrum(), GetFeedDownCorrectedSpectrumExtreme(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Input MC minimum b–>D spectra.
Definition at line 265 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectionFc(), ComputeHFPtSpectrum(), EstimateAndSetDirectEfficiencyRecoBin(), GetDirectAccEffCorrection(), Initialize(), operator=(), ResetStatUncEff(), SetAccEffCorrection(), SetDirectAccEffCorrection(), and ~AliHFPtSpectrum().
|
protected |
Input spectra
Definition at line 259 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectionFc(), GetDirectTheoreticalSpectrum(), Initialize(), operator=(), SetMCptSpectra(), and ~AliHFPtSpectrum().
|
protected |
Input MC b–>D spectra.
Definition at line 261 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectionFc(), GetDirectTheoreticalUpperLimitSpectrum(), Initialize(), operator=(), SetMCptDistributionsBounds(), and ~AliHFPtSpectrum().
|
protected |
Input MC maximum c–>D spectra.
Definition at line 262 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectionFc(), GetDirectTheoreticalLowerLimitSpectrum(), Initialize(), operator=(), SetMCptDistributionsBounds(), and ~AliHFPtSpectrum().
|
protected |
Systematic uncertainy on the raw yields.
Output spectra
Definition at line 284 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectionFc(), GetHistoFeedDownCorrectionFc(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Correction histo fc = 1 / ( 1 + (eff_b/eff_c)*(N_b/N_c) )
Definition at line 285 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectionFc(), GetHistoUpperLimitFeedDownCorrectionFc(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Maximum fc histo.
Definition at line 286 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectionFc(), GetHistoLowerLimitFeedDownCorrectionFc(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Minimum fc histo.
Definition at line 287 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), GetHistoFeedDownCorrectionFcVsEloss(), operator=(), and ~AliHFPtSpectrum().
|
protected |
c–>D Acceptance and efficiency correction
Definition at line 266 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), EstimateAndSetFeedDownEfficiencyRecoBin(), GetFeedDownAccEffCorrection(), Initialize(), operator=(), ResetStatUncEff(), SetAccEffCorrection(), and ~AliHFPtSpectrum().
|
protected |
Input MC c–>D spectra.
Definition at line 260 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), GetFeedDownTheoreticalSpectrum(), Initialize(), operator=(), SetFeedDownMCptSpectra(), SetMCptSpectra(), and ~AliHFPtSpectrum().
|
protected |
Input MC minimum c–>D spectra.
Definition at line 263 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), GetFeedDownTheoreticalUpperLimitSpectrum(), Initialize(), operator=(), SetFeedDownMCptDistributionsBounds(), SetMCptDistributionsBounds(), and ~AliHFPtSpectrum().
|
protected |
Input MC maximum b–>D spectra.
Definition at line 264 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), GetFeedDownTheoreticalLowerLimitSpectrum(), Initialize(), operator=(), SetFeedDownMCptDistributionsBounds(), SetMCptDistributionsBounds(), and ~AliHFPtSpectrum().
|
protected |
b–>D Acceptance and efficiency correction
Definition at line 267 of file AliHFPtSpectrum.h.
Referenced by CalculateCorrectedSpectrumNoFeedDown(), CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), ComputeHFPtSpectrum(), EstimateAndSetDirectEfficiencyRecoBin(), EstimateAndSetFeedDownEfficiencyRecoBin(), EstimateEfficiencyRecoBin(), Initialize(), operator=(), RebinTheoreticalSpectra(), SetFeedDownMCptDistributionsBounds(), SetFeedDownMCptSpectra(), SetMCptDistributionsBounds(), SetMCptSpectra(), SetReconstructedSpectrum(), SetReconstructedSpectrumSystematics(), and ~AliHFPtSpectrum().
|
protected |
Conservative corrected yield as TGraphAsymmErrors (syst from feed-down)
Definition at line 297 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), DrawSpectrum(), GetHistoCrossSectionFromYieldSpectrum(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Minimum corrected cross-section.
Definition at line 300 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), ComputeSystUncertainties(), GetHistoCrossSectionDataSystematics(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Corrected cross-section (stat unc. only)
Definition at line 298 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), GetHistoUpperLimitCrossSectionFromYieldSpectrum(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Maximum corrected cross-section.
Definition at line 299 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), GetHistoLowerLimitCrossSectionFromYieldSpectrum(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Corrected cross-section (syst. unc. from data only)
Definition at line 301 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), GetHistoCrossSectionFromYieldSpectrumVsEloss(), and operator=().
|
protected |
Uncertainty on the feed-down correction due to the prompt efficiency statistical uncertainty.
Definition at line 325 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), and GetFeedDownStatEffUncOnFc().
|
protected |
Uncertainty on the cross-section due to the prompt efficiency statistical uncertainty.
Definition at line 323 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), and GetFeedDownStatEffUncOnSigma().
|
protected |
Uncertainty on the cross-section due to the feed-down efficiency statistical uncertainty.
Definition at line 324 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), and GetDirectStatEffUncOnFc().
|
protected |
Definition at line 322 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), and GetDirectStatEffUncOnSigma().
|
protected |
Extreme correction as TGraphAsymmErrors.
Definition at line 290 of file AliHFPtSpectrum.h.
Referenced by CalculateCorrectedSpectrumNoFeedDown(), CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), ComputeHFPtSpectrum(), GetHistoFeedDownCorrectedSpectrum(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Corrected yield (stat unc. only)
Definition at line 291 of file AliHFPtSpectrum.h.
Referenced by CalculateCorrectedSpectrumNoFeedDown(), CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), GetHistoUpperLimitFeedDownCorrectedSpectrum(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Maximum corrected yield.
Definition at line 292 of file AliHFPtSpectrum.h.
Referenced by CalculateCorrectedSpectrumNoFeedDown(), CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), GetHistoLowerLimitFeedDownCorrectedSpectrum(), operator=(), and ~AliHFPtSpectrum().
|
protected |
Minimum corrected yield.
Definition at line 293 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), GetHistoFeedDownCorrectedSpectrumVsEloss(), operator=(), and ~AliHFPtSpectrum().
|
protected |
1: only one sign, 2: yield is for particle+anti-particle
Definition at line 315 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), operator=(), and SetIsEventPlaneAnalysis().
|
protected |
flag: whether to do estimates vs Ratio(c/b eloss) hypothesis
Definition at line 313 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), operator=(), and SetfIsStatUncEff().
|
protected |
nb of analyzed events
Definition at line 273 of file AliHFPtSpectrum.h.
Referenced by AliHFPtSpectrum(), CalculateFeedDownCorrectedSpectrumNb(), ComputeHFPtSpectrum(), operator=(), SetLuminosity(), and SetNormalization().
|
protected |
all reconstructed D Systematic uncertainties
Normalization factors
Definition at line 272 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), operator=(), and SetNormalization().
|
protected |
Ntuple of the calculation vs the Ratio(c/b eloss)
Definition at line 307 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), ComputeHFPtSpectrum(), operator=(), and ~AliHFPtSpectrum().
|
protected |
flag : when the analysis is done for In/Out of plane, divide the B-prediction by two
Definition at line 317 of file AliHFPtSpectrum.h.
Referenced by AliHFPtSpectrum(), CalculateCorrectedSpectrumNoFeedDown(), CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), ComputeHFPtSpectrum(), EstimateEfficiencyRecoBin(), operator=(), RebinTheoreticalSpectra(), and SetReconstructedSpectrum().
|
protected |
Conservative corrected cross-section as TGraphAsymmErrors (syst from feed-down)
Definition at line 306 of file AliHFPtSpectrum.h.
Referenced by ComputeHFPtSpectrum(), GetNtupleCrossSectionVsEloss(), operator=(), and ~AliHFPtSpectrum().
|
protected |
flag : consider (1) or not (0) the stat unc on the efficiencies
Definition at line 314 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumNb(), ComputeHFPtSpectrum(), operator=(), and SetIsParticlePlusAntiParticleYield().
|
protected |
flag: asymmetric uncertainties are (1) or not (0) considered
Definition at line 312 of file AliHFPtSpectrum.h.
Referenced by CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), ComputeHFPtSpectrum(), IsElossHypothesisCalculated(), operator=(), and SetComputeElossHypothesis().
|
protected |
number of pt bins
Definition at line 318 of file AliHFPtSpectrum.h.
Referenced by AliHFPtSpectrum(), CalculateCorrectedSpectrumNoFeedDown(), CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), ComputeHFPtSpectrum(), EstimateEfficiencyRecoBin(), operator=(), RebinTheoreticalSpectra(), SetReconstructedSpectrum(), and ~AliHFPtSpectrum().
|
protected |
Definition at line 319 of file AliHFPtSpectrum.h.
Referenced by AliHFPtSpectrum(), CalculateFeedDownCorrectedSpectrumFc(), CalculateFeedDownCorrectedSpectrumNb(), CalculateFeedDownCorrectionFc(), ComputeHFPtSpectrum(), operator=(), RebinTheoreticalSpectra(), SetReconstructedSpectrum(), and ~AliHFPtSpectrum().
|
protected |
Tab parameter and its uncertainty.
Definition at line 279 of file AliHFPtSpectrum.h.
Referenced by CalculateEfficiencyPtDepedentUncertainty(), ComputeSystUncertainties(), operator=(), and SetSystematicUncertainty().
|
protected |
use a pt-dependent efficiency uncertainty (Nb method unc.)
Definition at line 277 of file AliHFPtSpectrum.h.
Referenced by AliHFPtSpectrum(), CalculateFeedDownCorrectedSpectrumNb(), ComputeHFPtSpectrum(), operator=(), and SetTabParameter().
|
protected |
analyzed luminosity & uncertainty
Definition at line 274 of file AliHFPtSpectrum.h.
Referenced by AliHFPtSpectrum(), CalculateFeedDownCorrectedSpectrumNb(), ComputeHFPtSpectrum(), operator=(), and SetTriggerEfficiency().