Go
Top

Images:

Par fichier:

Analysis_CommonFunction_h.html
TypeFromPattern - deltaR - GetCutIndexSliceFromTH3 - GetCutIndexSliceFromTH2 - GetMassFromBeta - GetTOFMass - GetIBeta - GetMass - GetMassLine - GetMassLineQ - EfficiencyAndError - Efficiency - GetEventInRange - GetPredictionRescale - FindIntersectionBetweenTwoGraphs - FindRangeBetweenTwoGraphs - DistToHSCP - HowManyChargedHSCP - GetGenHSCPBeta - deltaROpositeTrack - IncreasedTreshold - loadDeDxTemplate -
Analysis_Cuts_txt.html

Analysis_Global_h.html
IntegratedLuminosityFromE - InitdEdx - InitBaseDirectory -
Analysis_PlotFunction_h.html
GetObjectFromPath - MakeDirectories - SaveCanvas - DrawPreliminary - DrawLegend - DrawStatBox - DrawTH2D - DrawSuperposedHistos - Smart_SetAxisRange - GetErrorBand -
Analysis_PlotStructure_h.html
stPlots_Init - stPlots_InitFromFile - stPlots_Clear - stPlots_FillTree - stPlots_Dump - stPlots_Draw - stPlots_DrawComparison -
Analysis_Samples_h.html
GetSampleDefinition - GetInputFiles - JobIdToIndex - keepOnlySamplesOfTypeX - keepOnlyTheXtoYSamples - keepOnlySamplesOfNameX - keepOnlySamplesOfNamesXtoY - keepOnlySamplesAt7and8TeVX - GetInitialNumberOfMCEvent - GetSampleWeight - GetSampleWeightMC - GetPUWeight -
Analysis_Samples_txt.html

Analysis_Step3_C.html
PassTrigger - PassPreselection - PassSelection - Analysis_FillControlAndPredictionHist - Analysis_Step3 - InitHistos - RescaledPt - SegSep - muonStations - scaleFactor -
Analysis_Step3_sh.html

Analysis_Step4_C.html
Analysis_Step4 -
Analysis_Step5_C.html
Analysis_Step5 - MassPrediction - PredictionAndControlPlot - CutFlow - SelectionPlot - GetSystematicOnPrediction - SignalMassPlot - Make2DPlot_Core - MakeExpLimitpLot - CosmicBackgroundSystematic - CheckPrediction - CollisionBackgroundSystematicFromFlip - CheckPredictionBin - Make2DPlot_Special - CompareRecoAndGenPt - CheckPUDistribution -
Analysis_Step6_C.html
Analysis_Step6 - if - CheckSignalUncertainty - MakePlot - printSummary - printSummaryPaper - GetSignalMeanHSCPPerEvent - DrawModelLimitWithBand - DrawRatioBands - Optimize - makeDataCard - saveHistoForLimit - saveVariationHistoForLimit - testShapeBasedAnalysis - computeSignificance - runCombine - Combine - useSample - toLatex -
Analysis_Step6_sh.html

DumpInfo_C.html
shapeSelection - printCluster - DumpCandidateInfo - PassTrigger - DumpInfo -
DumpInfo_sh.html

LaunchOnCondor_py.html
CreateTheConfigFile - CreateTheShellFile - CreateTheCmdFile - AddJobToCmdFile - CreateDirectoryStructure - SendCluster_LoadInputFiles - SendCluster_Create - SendCluster_Push - SendCluster_Submit - SendSingleJob - SendCMSJobs - GetListOfFiles - ListToString - ListToFile - FileToList - SendCMSMergeJob -
Launch_py.html
skipSamples -
tdrstyle_C.html
fixOverlay - setTDRStyle -

Par fonction:

HowManyChargedHSCP

defined in Analysis_CommonFunction_h.html at line 484
int HowManyChargedHSCP (const std::vector<reco::GenParticle>& genColl){
// count the number of charged generated HSCP in the event --> this is needed to reweights the events for different gluino ball fraction starting from f=10% samples

EfficiencyAndError

defined in Analysis_CommonFunction_h.html at line 216
double EfficiencyAndError(TH1* Histo, double CutX, double& error){
// same as before but also compute the error in the efficiency

GetMass

defined in Analysis_CommonFunction_h.html at line 133
double GetMass(double P, double I, bool MC){
// compute mass out of a momentum and dEdx value

deltaROpositeTrack

defined in Analysis_CommonFunction_h.html at line 513
double deltaROpositeTrack(const susybsm::HSCParticleCollection& hscpColl, const susybsm::HSCParticle& hscp){

GetEventInRange

defined in Analysis_CommonFunction_h.html at line 237
double GetEventInRange(double min, double max, TH1D* hist, double& error){
// return the number of entry in an histogram (and it's error) in a window defined by two cuts

FindRangeBetweenTwoGraphs

defined in Analysis_CommonFunction_h.html at line 337
void FindRangeBetweenTwoGraphs(TGraph* obs, TGraph* th, double Min, double Max, double Step, double ThUncertainty, double& minExclMass, double& maxExclMass){
// find the range of excluded masses. Necessary when low mass not excluded but higher masses are

deltaR

defined in Analysis_CommonFunction_h.html at line 85
double deltaR(double eta1, double phi1, double eta2, double phi2) {
// compute deltaR between two point (eta,phi) (eta,phi)

GetGenHSCPBeta

defined in Analysis_CommonFunction_h.html at line 499
void GetGenHSCPBeta (const std::vector<reco::GenParticle>& genColl, double& beta1, double& beta2, bool onlyCharged){
// returns the generated beta of the two firsts HSCP in the events

GetCutIndexSliceFromTH2

defined in Analysis_CommonFunction_h.html at line 100
TH1D* GetCutIndexSliceFromTH2(TH2D* tmp, unsigned int CutIndex, string Name="_py"){
// function to go form a TH2 plot with cut index on the x axis to a TH1

TypeFromPattern

defined in Analysis_CommonFunction_h.html at line 59
int TypeFromPattern(const std::string& InputPattern){
// return the TypeMode from a string inputPattern

GetTOFMass

defined in Analysis_CommonFunction_h.html at line 115
double GetTOFMass(double P, double TOF){
// compute mass out of a momentum and tof value

GetPredictionRescale

defined in Analysis_CommonFunction_h.html at line 245
void GetPredictionRescale(std::string InputPattern, double& Rescale, double& RMS, bool ForceRecompute=false)
// not used anymore, was computing a scale factor between datadriven prediction and observation using the M<75GeV events

GetIBeta

defined in Analysis_CommonFunction_h.html at line 120
double GetIBeta(double I, bool MC){
// estimate beta from a dEdx value, if dEdx is below the allowed threshold returns a negative beta value

GetMassLine

defined in Analysis_CommonFunction_h.html at line 145
TF1* GetMassLine(double M, bool MC){
// return a TF1 corresponding to a mass line in the momentum vs dEdx 2D plane

FindIntersectionBetweenTwoGraphs

defined in Analysis_CommonFunction_h.html at line 310
double FindIntersectionBetweenTwoGraphs(TGraph* obs, TGraph* th, double Min, double Max, double Step, double ThUncertainty=0, bool debug=false){
// find the intersection between two graphs... very useful to know what is the excluded mass range from an observed xsection limit and theoretical xsection

IncreasedTreshold

defined in Analysis_CommonFunction_h.html at line 573
bool IncreasedTreshold(const trigger::TriggerEvent& trEv, const edm::InputTag& InputPath, double NewThreshold, double etaCut, int NObjectAboveThreshold, bool averageThreshold)

DistToHSCP

defined in Analysis_CommonFunction_h.html at line 461
double DistToHSCP (const susybsm::HSCParticle& hscp, const std::vector<reco::GenParticle>& genColl, int& IndexOfClosest){
// compute the distance between a "reconstructed" HSCP candidate and the closest geenrated HSCP

loadDeDxTemplate

defined in Analysis_CommonFunction_h.html at line 729
TH3F* loadDeDxTemplate(string path){

GetMassLineQ

defined in Analysis_CommonFunction_h.html at line 169
TF1* GetMassLineQ(double M, double Charge=1, bool MC=false)

GetMassFromBeta

defined in Analysis_CommonFunction_h.html at line 109
double GetMassFromBeta(double P, double beta){
// compute mass out of a beta and momentum value

GetCutIndexSliceFromTH3

defined in Analysis_CommonFunction_h.html at line 94
TH2D* GetCutIndexSliceFromTH3(TH3D* tmp, unsigned int CutIndex, string Name="zy"){
// function to go form a TH3 plot with cut index on the x axis to a TH2

Efficiency

defined in Analysis_CommonFunction_h.html at line 230
double Efficiency(TH2* Histo, double CutX, double CutY){
// return the selection efficiency for a given disribution (TH2) and for a given recangular signal region ... Nothing but the integral above the cut divided by the number of events

InitBaseDirectory

defined in Analysis_Global_h.html at line 224
void InitBaseDirectory(){
// you are please to add the line for your case and not touch the line of the other users

InitdEdx

defined in Analysis_Global_h.html at line 206
void InitdEdx(std::string dEdxS_Label_){
// function used to define Axis range and legend automatically from the estimator label

IntegratedLuminosityFromE

defined in Analysis_Global_h.html at line 102
string IntegratedLuminosityFromE(double SQRTS_){

GetErrorBand

defined in Analysis_PlotFunction_h.html at line 446
TCutG* GetErrorBand(string name, int N, double* Mass, double* Low, double* High, double MinLow, double MaxHigh){
// return a TCUTG corresponding to the uncertainty on a xsection

MakeDirectories

defined in Analysis_PlotFunction_h.html at line 90
void MakeDirectories(std::string path){
// create a directory/subdirectory on disk

DrawPreliminary

defined in Analysis_PlotFunction_h.html at line 227
void DrawPreliminary(double SQRTS_, double Lumi, double X=0.40, double Y=0.995, double W=0.82, double H=0.945){

DrawStatBox

defined in Analysis_PlotFunction_h.html at line 269
void DrawStatBox(TObject** Histos, std::vector<std::string> legend, bool Mean, double X=0.15, double Y=0.93, double W=0.15, double H=0.03)
// draw the stat box

SaveCanvas

defined in Analysis_PlotFunction_h.html at line 95
void SaveCanvas(TCanvas* c, std::string path, std::string name, bool OnlyPPNG=false){
// save a TCanvas on disk in a few different format (mind that 2D plots can be huge if saved in eps/C/pdf)

DrawSuperposedHistos

defined in Analysis_PlotFunction_h.html at line 327
void DrawSuperposedHistos(TH1** Histos, std::vector<std::string> legend, std::string Style_, std::string Xlegend, std::string Ylegend, double xmin, double xmax, double ymin, double ymax, bool Normalize=false, bool same=false, bool lastBinOverflow=false, bool firstBinOverflow=false)
// Draw a list of TH1 and superimposed them

DrawTH2D

defined in Analysis_PlotFunction_h.html at line 300
void DrawTH2D(TH2D** Histos, std::vector<std::string> legend, std::string Style_, std::string Xlegend, std::string Ylegend, double xmin, double xmax, double ymin, double ymax)
// draw a TH2D histogram

DrawLegend

defined in Analysis_PlotFunction_h.html at line 233
void DrawLegend (TObject** Histos, std::vector<std::string> legend, std::string Title, std::string Style_, double X=0.79, double Y=0.92, double W=0.20, double H=0.05)
// handfull function to draw the legend associated to a vector of histogram

GetObjectFromPath

defined in Analysis_PlotFunction_h.html at line 83
TObject* GetObjectFromPath(TDirectory* Container, TDirectory* File, std::string Path, bool GetACopy=false){
// similar to the above code

Smart_SetAxisRange

defined in Analysis_PlotFunction_h.html at line 431
void Smart_SetAxisRange(TH2D* histo){
// automatically determined what is the best axis ranges for a TH2D

stPlots_Draw

defined in Analysis_PlotStructure_h.html at line 1091
void stPlots_Draw(stPlots& st, std::string SavePath, std::string LegendTitle, unsigned int CutIndex)
// draw all plots that are not meant for comparison with other samples (mostly 2D plots that can't be superimposed)

stPlots_InitFromFile

defined in Analysis_PlotStructure_h.html at line 738
bool stPlots_InitFromFile(TFile* HistoFile, stPlots& st, std::string BaseName)
// load all the plots from an already existing file

stPlots_DrawComparison

defined in Analysis_PlotStructure_h.html at line 1598
void stPlots_DrawComparison(std::string SavePath, std::string LegendTitle, unsigned int CutIndex, unsigned int CutIndexTight, stPlots* st1, stPlots* st2=NULL, stPlots* st3=NULL, stPlots* st4=NULL, stPlots* st5=NULL, stPlots* st6=NULL, stPlots* st7=NULL)
// draw all plots that meant for comparison with other samples (mostly 1D plots that can be superimposed)

stPlots_Init

defined in Analysis_PlotStructure_h.html at line 374
void stPlots_Init(TFile* HistoFile, stPlots& st, std::string BaseName, unsigned int NCuts, bool SkipSelectionPlot=false, bool isSignal=true, unsigned int NCuts_Flip=0)
// number of samples in our analysis... The size of the file can easilly explode

stPlots_Clear

defined in Analysis_PlotStructure_h.html at line 957
void stPlots_Clear(stPlots* st, bool WriteFirst=false)
// Write the histograms to the file on disk and properly clean the memory from all the histograms

stPlots_Dump

defined in Analysis_PlotStructure_h.html at line 985
void stPlots_Dump(stPlots& st, FILE* pFile, int CutIndex){
// dump a full preselection and selection cut flow table

stPlots_FillTree

defined in Analysis_PlotStructure_h.html at line 967
void stPlots_FillTree(stPlots* st, unsigned int Run, unsigned int Event, unsigned int Hscp, double Pt, double I, double TOF, double Mass, double dZ, double dXY, double dR, double eta, double phi, int MaxEntry=20000){
// add one candidate to the bookeeping tree --> the event must be saved in the tree if you want to find it back with the DumpInfo.C code later on

GetInitialNumberOfMCEvent

defined in Analysis_Samples_h.html at line 254
unsigned long GetInitialNumberOfMCEvent(const vector<string>& fileNames)
// this is useful to determine how to normalize the events (compute weight)

keepOnlyTheXtoYSamples

defined in Analysis_Samples_h.html at line 195
void keepOnlyTheXtoYSamples(std::vector<stSample>& samples, unsigned int X, unsigned int Y){

GetSampleWeight

defined in Analysis_Samples_h.html at line 280
double GetSampleWeight(const double& IntegratedLuminosityInPb, const double& IntegratedLuminosityInPbBeforeTriggerChange, const double& CrossSection, const double& MCEvents, int period){
// compute event weight for the signal samples based on number of events in the sample, cross section and intergated luminosity

keepOnlySamplesOfNamesXtoY

defined in Analysis_Samples_h.html at line 204
void keepOnlySamplesOfNamesXtoY(std::vector<stSample>& samples, std::vector<string> NamesXtoY){

keepOnlySamplesOfNameX

defined in Analysis_Samples_h.html at line 200
void keepOnlySamplesOfNameX(std::vector<stSample>& samples, string NameX){

keepOnlySamplesAt7and8TeVX

defined in Analysis_Samples_h.html at line 214
void keepOnlySamplesAt7and8TeVX(std::vector<stSample>& samples, double SQRTS_){

GetSampleWeightMC

defined in Analysis_Samples_h.html at line 292
double GetSampleWeightMC(const double& IntegratedLuminosityInPb, const std::vector<string> fileNames, const double& XSection, const double& SampleSize, double MaxEvent){
// compute event weight for the MC background samples based on number of events in the sample, cross section and intergated luminosity

GetSampleDefinition

defined in Analysis_Samples_h.html at line 143
void GetSampleDefinition(std::vector<stSample>& samples, std::string sampleTxtFile="Analysis_Samples.txt"){

keepOnlySamplesOfTypeX

defined in Analysis_Samples_h.html at line 191
void keepOnlySamplesOfTypeX(std::vector<stSample>& samples, int TypeX){

GetPUWeight

defined in Analysis_Samples_h.html at line 352
double GetPUWeight(const fwlite::ChainEvent& ev, const std::string& pileup, double &PUSystFactor, edm::LumiReWeighting& LumiWeightsMC, edm::LumiReWeighting& LumiWeightsMCSyst){
// compute a weight to make sure that the pileup distribution in Signal/Background MC is compatible to the pileup distribution in data

JobIdToIndex

defined in Analysis_Samples_h.html at line 174
int JobIdToIndex(string JobId, const std::vector<stSample>& samples){

GetInputFiles

defined in Analysis_Samples_h.html at line 151
void GetInputFiles(stSample sample, std::string BaseDirectory_, std::vector<std::string>& inputFiles, int period=0){

Analysis_Step3

defined in Analysis_Step3_C.html at line 1017
void Analysis_Step3(char* SavePath)
// Looping on all events, tracks, selection and check how many events are entering the mass distribution

muonStations

defined in Analysis_Step3_C.html at line 1623
int muonStations(reco::HitPattern hitPattern) {
//Counts the number of muon stations used in track fit only counting DT and CSC stations.

scaleFactor

defined in Analysis_Step3_C.html at line 1640
double scaleFactor(double eta) {

Analysis_FillControlAndPredictionHist

defined in Analysis_Step3_C.html at line 808
void Analysis_FillControlAndPredictionHist(const susybsm::HSCParticle& hscp, const reco::DeDxData* dedxSObj, const reco::DeDxData* dedxMObj, const reco::MuonTimeExtra* tof, stPlots* st){
// all code for the filling of the ABCD related histograms --> this information will be used later in Step4 for the actual datadriven prediction

PassTrigger

defined in DumpInfo_C.html at line 483
bool PassTrigger(const fwlite::ChainEvent& ev)

PassPreselection

defined in Analysis_Step3_C.html at line 367
bool PassPreselection(const susybsm::HSCParticle& hscp, const reco::DeDxData* dedxSObj, const reco::DeDxData* dedxMObj, const reco::MuonTimeExtra* tof, const reco::MuonTimeExtra* dttof, const reco::MuonTimeExtra* csctof, const fwlite::ChainEvent& ev, stPlots* st, const double& GenBeta, bool RescaleP, const double& RescaleI, const double& RescaleT)

PassSelection

defined in Analysis_Step3_C.html at line 735
bool PassSelection(const susybsm::HSCParticle& hscp, const reco::DeDxData* dedxSObj, const reco::DeDxData* dedxMObj, const reco::MuonTimeExtra* tof, const fwlite::ChainEvent& ev, const int& CutIndex, stPlots* st, const bool isFlip, const double& GenBeta, bool RescaleP, const double& RescaleI, const double& RescaleT){
// check if one HSCP candidate is passing the selection (the function also has many more arguments because it is used to fill some histograms AND to evaluate the systematics

SegSep

defined in Analysis_Step3_C.html at line 1576
double SegSep(const susybsm::HSCParticle& hscp, const fwlite::ChainEvent& ev, double& minPhi, double& minEta) {

InitHistos

defined in Analysis_Step3_C.html at line 1549
void InitHistos(stPlots* st){

RescaledPt

defined in Analysis_Step3_C.html at line 1564
double RescaledPt(const double& pt, const double& eta, const double& phi, const int& charge)
// code needed for the evaluation of the systematics related to pt measurement

Analysis_Step4

defined in Analysis_Step4_C.html at line 87
void Analysis_Step4(std::string InputPattern)

PredictionAndControlPlot

defined in Analysis_Step5_C.html at line 587
void PredictionAndControlPlot(string InputPattern, string Data, unsigned int CutIndex, unsigned int CutIndex_Flip){
// make some control plots to show that ABCD method can be used

MakeExpLimitpLot

defined in Analysis_Step5_C.html at line 2327
void MakeExpLimitpLot(string Input, string Output){

CheckPUDistribution

defined in Analysis_Step5_C.html at line 3489
void CheckPUDistribution(string InputPattern, unsigned int CutIndex){

Make2DPlot_Special

defined in Analysis_Step5_C.html at line 3210
void Make2DPlot_Special(string InputPattern, string InputPattern2){//, unsigned int CutIndex){

CompareRecoAndGenPt

defined in Analysis_Step5_C.html at line 3405
void CompareRecoAndGenPt(string InputPattern){

CheckPrediction

defined in Analysis_Step5_C.html at line 2528
void CheckPrediction(string InputPattern, string HistoSuffix, string DataType){

GetSystematicOnPrediction

defined in Analysis_Step5_C.html at line 1347
void GetSystematicOnPrediction(string InputPattern, string DataName){
// Determine the systematic uncertainty by computing datadriven prediction from different paths (only works with 3D ABCD method)

SignalMassPlot

defined in Analysis_Step5_C.html at line 1832
void SignalMassPlot(string InputPattern, unsigned int CutIndex){

CollisionBackgroundSystematicFromFlip

defined in Analysis_Step5_C.html at line 2665
void CollisionBackgroundSystematicFromFlip(string InputPattern, string DataType){

MassPrediction

defined in Analysis_Step5_C.html at line 234
void MassPrediction(string InputPattern, unsigned int CutIndex, string HistoSuffix, bool showMC, string DataName){
// Make the plot of the mass distibution: Observed, data-driven prediciton and signal expectation

CutFlow

defined in Analysis_Step5_C.html at line 1223
void CutFlow(string InputPattern, unsigned int CutIndex){
// print the event flow table for all signal point and Data and MCTr

CheckPredictionBin

defined in Analysis_Step5_C.html at line 3082
void CheckPredictionBin(string InputPattern, string HistoSuffix, string DataType, string bin){

SelectionPlot

defined in Analysis_Step5_C.html at line 1273
void SelectionPlot(string InputPattern, unsigned int CutIndex, unsigned int CutIndexTight){
// make all plots of the preselection and selection variables as well as some plots showing 2D planes

CosmicBackgroundSystematic

defined in Analysis_Step5_C.html at line 2373
void CosmicBackgroundSystematic(string InputPattern, string DataType){

Analysis_Step5

defined in Analysis_Step5_C.html at line 92
void Analysis_Step5()

Make2DPlot_Core

defined in Analysis_Step5_C.html at line 1868
void Make2DPlot_Core(string InputPattern, unsigned int CutIndex){

saveVariationHistoForLimit

defined in Analysis_Step6_C.html at line 2422
void saveVariationHistoForLimit(TH1* histo, TH1* vardown, string Name, string variationName){
//save histogram with variation in root file (save it as symetrical up and down variation)

toLatex

defined in Analysis_Step6_C.html at line 3309
string toLatex(double value) {

if

defined in Analysis_Step6_C.html at line 1089
if(Combine){
////////////////////////////////////// plot requested by G. Landsberg

makeDataCard

defined in Analysis_Step6_C.html at line 2364
void makeDataCard(string outpath, string rootPath, string ChannelName, string SignalName, double Obs, double Pred, double PredRelErr, double Sign, double SignStat, double SignalUnc, bool Shape){
// produce the Higgs combine stat tool datacard

MakePlot

defined in Analysis_Step6_C.html at line 1711
TGraph* MakePlot(FILE* pFile, FILE* talkFile, string InputPattern, string ModelName, int XSectionType, std::vector<stSample>& modelSamples, double& LInt){

runCombine

defined in Analysis_Step6_C.html at line 2509
bool runCombine(bool fastOptimization, bool getXsection, bool getSignificance, string& InputPattern, string& signal, unsigned int CutIndex, bool Shape, bool Temporary, stAllInfo& result, TH1* MassData, TH1* MassPred, TH1* MassSign, TH1* MassSignP, TH1* MassSignI, TH1* MassSignM, TH1* MassSignT, TH1* MassSignPU){
//run the higgs combine stat tool using predicted mass shape distribution (possibly do shape based analysis and/or cut on mass) OR 1D histogram output from ABCD (only do cut and count without mass cut)

printSummaryPaper

defined in Analysis_Step6_C.html at line 1812
void printSummaryPaper(FILE* pFile, FILE* talkFile, string InputPattern, string ModelName, std::vector<stSample>& modelSamples){

computeSignificance

defined in Analysis_Step6_C.html at line 2485
double computeSignificance(string datacard, bool expected, string& signal, string massStr, float Strength){
//compute the significance using a ProfileLikelihood (assuming datacard is already produced)

Optimize

defined in Analysis_Step6_C.html at line 2146
void Optimize(string InputPattern, string Data, string signal, bool shape, bool cutFromFile){
//will run on all possible selection and try to identify which is the best one for this sample

GetSignalMeanHSCPPerEvent

defined in Analysis_Step6_C.html at line 1856
double GetSignalMeanHSCPPerEvent(string InputPattern, unsigned int CutIndex, double MinRange_, double MaxRange_){

Analysis_Step6

defined in Analysis_Step6_C.html at line 197
void Analysis_Step6(string MODE="COMPILE", string InputPattern="", string signal=""){

Combine

defined in Analysis_Step6_C.html at line 3042
bool Combine(string InputPattern, string signal7, string signal8){

useSample

defined in Analysis_Step6_C.html at line 3300
bool useSample(int TypeMode, string sample) {

printSummary

defined in Analysis_Step6_C.html at line 1776
void printSummary(FILE* pFile, FILE* talkFile, string InputPattern, string ModelName, std::vector<stSample>& modelSamples){

DrawModelLimitWithBand

defined in Analysis_Step6_C.html at line 1878
void DrawModelLimitWithBand(string InputPattern){

CheckSignalUncertainty

defined in Analysis_Step6_C.html at line 1536
TGraph* CheckSignalUncertainty(FILE* pFile, FILE* talkFile, string InputPattern, string ModelName, std::vector<stSample>& modelSample){

DrawRatioBands

defined in Analysis_Step6_C.html at line 1968
void DrawRatioBands(string InputPattern)
// I don't think two loops are needed, neither all these arrays...

testShapeBasedAnalysis

defined in Analysis_Step6_C.html at line 2432
void testShapeBasedAnalysis(string InputPattern, string signal){
//this function just compute the result of the shape based analysis using the optimal point from the cut&count analysis

saveHistoForLimit

defined in Analysis_Step6_C.html at line 2404
void saveHistoForLimit(TH1* histo, string Name, string Id){
//save histogram in root file (and it's statistical variation if it's not observed date histogram)

printCluster

defined in DumpInfo_C.html at line 266
void printCluster(FILE* pFile, const SiStripCluster* Cluster)

DumpCandidateInfo

defined in DumpInfo_C.html at line 286
void DumpCandidateInfo(const susybsm::HSCParticle& hscp, const fwlite::ChainEvent& ev, FILE* pFile)

shapeSelection

defined in DumpInfo_C.html at line 121
bool shapeSelection(const std::vector<unsigned char> & ampls)

DumpInfo

defined in DumpInfo_C.html at line 494
void DumpInfo(string Pattern, int CutIndex=0, double MassMin=-1)

ListToString

defined in LaunchOnCondor_py.html at line 359
def ListToString(InputList):

SendCMSJobs

defined in LaunchOnCondor_py.html at line 326
def SendCMSJobs(FarmDirectory, JobName, ConfigFile, InputFiles, NJobs, Argv):

FileToList

defined in LaunchOnCondor_py.html at line 371
def FileToList(path):

SendSingleJob

defined in LaunchOnCondor_py.html at line 321
def SendSingleJob(FarmDirectory, JobName, Argv):

SendCMSMergeJob

defined in LaunchOnCondor_py.html at line 379
def SendCMSMergeJob(FarmDirectory, JobName, InputFiles, OutputFile, KeepStatement):

CreateTheShellFile

defined in LaunchOnCondor_py.html at line 121
def CreateTheShellFile(argv):

CreateTheConfigFile

defined in LaunchOnCondor_py.html at line 84
def CreateTheConfigFile(argv):

SendCluster_Push

defined in LaunchOnCondor_py.html at line 287
def SendCluster_Push(Argv):

ListToFile

defined in LaunchOnCondor_py.html at line 365
def ListToFile(InputList, outputFile):

SendCluster_Submit

defined in LaunchOnCondor_py.html at line 307
def SendCluster_Submit():

CreateTheCmdFile

defined in LaunchOnCondor_py.html at line 201
def CreateTheCmdFile():

SendCluster_LoadInputFiles

defined in LaunchOnCondor_py.html at line 249
def SendCluster_LoadInputFiles(path, NJobs):

AddJobToCmdFile

defined in LaunchOnCondor_py.html at line 223
def AddJobToCmdFile():

CreateDirectoryStructure

defined in LaunchOnCondor_py.html at line 241
def CreateDirectoryStructure(FarmDirectory):

SendCluster_Create

defined in LaunchOnCondor_py.html at line 271
def SendCluster_Create(FarmDirectory, JobName):

GetListOfFiles

defined in LaunchOnCondor_py.html at line 335
def GetListOfFiles(Prefix, InputPattern, Suffix):

skipSamples

defined in Launch_py.html at line 60
def skipSamples(type, name):

fixOverlay

defined in tdrstyle_C.html at line 69
void fixOverlay() {

setTDRStyle

defined in tdrstyle_C.html at line 73
void setTDRStyle() {