Ejemplo n.º 1
0
    else:
        c = ROOT.TCanvas("c", "")
        #        if hist_to_plot == "el_mva":
        #            c.SetLogy()
        h_sumMC.Draw("hist")
        sum.Draw("histsame")
        h_sumMC.Draw("histsame")
        data.Draw("epsame")
#--------------- lumi box and legend-----------------
    if hist_name == "cos_theta" or hist_name == "el_mva":
        legend_pos = "top-left"
    else:
        legend_pos = "top-right"

    if legend_pos == "top-right":
        lumibox = lumi_textbox(Lumi, "top-left")
    if legend_pos == "top-left":
        lumibox = lumi_textbox(Lumi, "top-right")

    hist_list = mc_to_plot.values()
    hist_list.reverse()  # reverse order of mc histograms for the legend entry
    hist_list.append(qcd)
    hist_list.insert(0, data)

    leg = legend(hist_list,
                 names=process_names,
                 styles=["p", "f"],
                 width=0.25,
                 pos=legend_pos)

    outfilename = "Plots/" + channel + "/" + mode1 + mode1a + "/" + hist_to_plot + mode2 + weight + ".pdf"
Ejemplo n.º 2
0
    else:
        c = ROOT.TCanvas("c","")
#        if hist_to_plot == "el_mva":
#            c.SetLogy()
        h_sumMC.Draw("hist")
        sum.Draw("histsame")
        h_sumMC.Draw("histsame")
        data.Draw("epsame")
#--------------- lumi box and legend-----------------
    if hist_name == "cos_theta" or hist_name == "el_mva":
        legend_pos = "top-left"
    else:
        legend_pos = "top-right"

    if legend_pos == "top-right":
        lumibox = lumi_textbox(Lumi,"top-left")
    if legend_pos == "top-left":
        lumibox = lumi_textbox(Lumi,"top-right")
    
    hist_list = mc_to_plot.values()
    hist_list.reverse() # reverse order of mc histograms for the legend entry
    hist_list.append(qcd)
    hist_list.insert(0,data)
    
    leg = legend(
        hist_list,
        names = process_names,
        styles=["p", "f"],
        width=0.25,
        pos = legend_pos
        )
Ejemplo n.º 3
0
            make_histogram(var, dataGroup, cuts.name, openedFiles, lumis, s,
                           "antiiso", cuts.antiIsoCutsData)

            stack = make_stack(var, cuts.name + s, MCGroups, dataGroup,
                               openedFiles, s, "antiiso", lumis,
                               cuts.antiIsoCutsMC, cuts.antiIsoCutsData, "",
                               cuts.name)
            stacks[var.name + s + "antiiso"] = stack

    #print "cuts",cuts.isoCutsData

    tdrstyle.tdrstyle()
    cst = TCanvas("Histogram", "Jet Systematics in final selection", 10, 10,
                  1000, 1000)

    lumibox = lumi_textbox(lumi_iso["mu"])
    histos = []

    hData = dataGroup.getHistogram(var, "Nominal", "iso" + cuts.name)
    #hQCDShapeOrig = dataGroup.getHistogram(var, "Nominal", "antiiso")
    hData.Draw("e1")
    hData.SetMarkerStyle(20)
    hData.SetAxisRange(0, 1000, "Y")
    stackSys = THStack("Stacksys", "stackName")
    for s in systematics:
        if s == "Nominal":
            stackNom = stacks[var.name + s + "iso"]
        else:
            for st in syst_type:
                stack = stacks[var.name + s + st + "iso"]
                h1 = TH1D(var.shortName + "_" + s + st,
Ejemplo n.º 4
0
def data_mc_plot(samples, plot_def, name, lepton_channel, lumi, weight, physics_processes, use_antiiso=False):

    logger.info('Plot in progress %s' % name)

    merge_cmds = PhysicsProcess.get_merge_dict(physics_processes) #The actual merge dictionary

    var = plot_def['var']

    #Id var is a list/tuple, assume
    if not isinstance(var, basestring):
        try:
            if lepton_channel == 'ele':
                var = var[0]
            elif lepton_channel == 'mu':
                var = var[1]
        except Exception as e:
            logger.error("Plot variable 'var' specification incorrect for multi-variable plot: %s" % str(var))
            raise e
    cut = None
    if lepton_channel == 'ele':
        cut = plot_def['elecut']
    elif lepton_channel == 'mu':
        cut = plot_def['mucut']

    cut_str = str(cut)

    plot_range = plot_def['range']

    do_norm = False
    if 'normalize' in plot_def.keys() and plot_def['normalize']:
        do_norm = True
    hists_mc = dict()
    hists_data = dict()
    for name, sample in samples.items():
        logger.debug("Starting to plot %s" % name)
        if sample.isMC:
            hist = sample.drawHistogram(var, cut_str, weight=str(weight), plot_range=plot_range)
            hist.Scale(sample.lumiScaleFactor(lumi))
            hists_mc[sample.name] = hist
            if do_norm:
                Styling.mc_style_nostack(hists_mc[sample.name], sample.name)
            else:
                Styling.mc_style(hists_mc[sample.name], sample.name)

            if "fitpars" in plot_def.keys():
                rescale_to_fit(sample.name, hist, plot_def["fitpars"][lepton_channel])
        elif "antiiso" in name and plot_def['estQcd'] and not use_antiiso:

            # Make loose template
            #Y U NO LOOP :) -JP
            region = '2j1t'
            if '2j0t' in plot_def['estQcd']: region='2j0t'
            if '3j0t' in plot_def['estQcd']: region='3j0t'
            if '3j1t' in plot_def['estQcd']: region='3j1t'
            if '3j2t' in plot_def['estQcd']: region='3j2t'

            qcd_extra_cut = Cuts.deltaR(0.3)*Cuts.antiiso(lepton_channel)

            #Take the loose template with a good shape from the N-jet, M-tag, post lepton selection region with high statistics
            qcd_loose_cut = cutlist[region]*cutlist['presel_'+lepton_channel]*qcd_extra_cut

            #Take the template which can be correctly normalized from the actual region with inverted isolation cuts
            qcd_cut = cut*qcd_extra_cut

            hist_qcd_loose = sample.drawHistogram(var, str(qcd_loose_cut), weight="1.0", plot_range=plot_range)
            hist_qcd = sample.drawHistogram(var, str(qcd_cut), weight="1.0", plot_range=plot_range)
            logger.debug("Using the QCD scale factor %s: %.2f" % (plot_def['estQcd'], qcdScale[lepton_channel][plot_def['estQcd']]))
            

            hist_qcd.Scale(qcdScale[lepton_channel][plot_def['estQcd']])
            hist_qcd_loose.Scale(hist_qcd.Integral()/hist_qcd_loose.Integral())
            if var=='cos_theta':
                hist_qcd=hist_qcd_loose
            sampn = "QCD"+sample.name

            #Rescale the QCD histogram to the eta_lj fit
            if "fitpars" in plot_def.keys():
                rescale_to_fit(sampn, hist_qcd, plot_def["fitpars"][lepton_channel])

            hists_mc[sampn] = hist_qcd
            hists_mc[sampn].SetTitle('QCD')
            if do_norm:
                Styling.mc_style_nostack(hists_mc[sampn], 'QCD')
            else:
                Styling.mc_style(hists_mc[sampn], 'QCD')

        #Real ordinary data in the isolated region
        elif not "antiiso" in name or use_antiiso:
            hist_data = sample.drawHistogram(var, cut_str, weight="1.0", plot_range=plot_range)
            hist_data.SetTitle('Data')
            Styling.data_style(hist_data)
            hists_data[name] = hist_data


    if len(hists_data.values())==0:
        raise Exception("Couldn't draw the data histogram")

    #Combine the subsamples to physical processes
    hist_data = sum(hists_data.values())
    merge_cmds['QCD']=["QCD"+merge_cmds['data'][0]]
    order=['QCD']+PhysicsProcess.desired_plot_order
    if plot_def['log']:
        order = PhysicsProcess.desired_plot_order_log+['QCD']
    merged_hists = merge_hists(hists_mc, merge_cmds, order=order)

    if hist_data.Integral()<=0:
        logger.error(hists_data)
        logger.error("hist_data.entries = %d" % hist_data.GetEntries())
        logger.error("hist_data.integral = %d" % hist_data.Integral())
        raise Exception("Histogram for data was empty. Something went wrong, please check.")

    if do_norm:
        for k,v in merged_hists.items():
            v.Scale(1./v.Integral())
        hist_data.Scale(1./hist_data.Integral())

    htot = sum(merged_hists.values())

    chi2 = hist_data.Chi2Test(htot, "UW CHI2/NDF")
    if chi2>20:#FIXME: uglyness
        logger.error("The chi2 between data and MC is large (%s, chi2=%.2f). You may have errors with your samples!" %
            (name, chi2)
        )
        logger.info("MC  : %s" % " ".join(map(lambda x: "%.1f" % x, list(htot.y()))))
        logger.info("DATA: %s" % " ".join(map(lambda x: "%.1f" % x, list(hist_data.y()))))
        logger.info("diff: %s" % str(
            " ".join(map(lambda x: "%.1f" % x, numpy.abs(numpy.array(list(htot.y())) - numpy.array(list(hist_data.y())))))
        ))

    merged_hists_l = merged_hists.values()

    PhysicsProcess.name_histograms(physics_processes, merged_hists)

    leg_style = ['p','f']
    if do_norm:
        leg_style=['p','l']
    leg = legend([hist_data] + list(reversed(merged_hists_l)), legend_pos=plot_def['labloc'], styles=leg_style)

    canv = ROOT.TCanvas()

    #Make the stacks
    stacks_d = OrderedDict()
    stacks_d["mc"] = merged_hists_l
    stacks_d["data"] = [hist_data]

    #label
    xlab = plot_def['xlab']
    if not isinstance(xlab, basestring):
        if lepton_channel == 'ele':
            xlab = xlab[0]
        else:
            xlab = xlab[1]
    ylab = 'N / '+str((1.*(plot_range[2]-plot_range[1])/plot_range[0]))
    if plot_def['gev']:
        ylab+=' GeV'
    fact = 1.5
    if plot_def['log']:
        fact = 10

    plow=0.3
    if do_norm:
        plow=0

    #Make a separate pad for the stack plot
    p1 = ROOT.TPad("p1", "p1", 0, plow, 1, 1)
    p1.Draw()
    p1.SetTicks(1, 1);
    p1.SetGrid();
    p1.SetFillStyle(0);
    p1.cd()

    stacks = plot_hists_stacked(p1, stacks_d, x_label=xlab, y_label=ylab, max_bin_mult = fact, do_log_y = plot_def['log'], stack = (not do_norm))

    #Put the the lumi box where the legend is not
    boxloc = 'top-right'
    if plot_def['labloc'] == 'top-right':
        boxloc = 'top-left'
    chan = 'Electron'
    if lepton_channel == "mu":
        chan = 'Muon'

    additional_comments = ""
    if 'cutname' in plot_def.keys():
        additional_comments += ", " + plot_def['cutname'][lepton_channel]
    lbox = lumi_textbox(lumi,
        boxloc,
        'preliminary',
        chan + ' channel' + additional_comments
    )

    #Draw everything
    lbox.Draw()
    leg.Draw()
    canv.Draw()

    #Keep the handles just in case
    canv.PAD1 = p1
    canv.STACKS = stacks
    canv.LEGEND = legend
    canv.LUMIBOX = lbox

    return canv, merged_hists, htot, hist_data
Ejemplo n.º 5
0
    Styling.data_style(data_post)

    hi = [data_post, htrue, hcomphep]
    chi2 = data_post.Chi2Test(htrue, "WW CHI2/NDF")
    #htrue.SetTitle(htrue.GetTitle() + " #chi^{2}/#nu = %.1f" % chi2)
    #hi_norm = hi
    hi_norm = map(post_normalize, hi)
    for h in hi[1:]:
        h.SetMarkerSize(0)
    of = OutputFolder(subdir='unfolding/%s' % lep)
    canv = plot_hists(hi_norm, x_label="cos #theta*", draw_cmd=len(hi)*["E1"], y_label="a.u.")
    #leg = legend(hi, styles=['p', 'f'], legend_pos='bottom-right', nudge_x=-0.29, nudge_y=-0.08)
    leg = legend(hi, styles=['p', 'f'], legend_pos='top-left', nudge_y=-0.14)
    lb = lumi_textbox(lumi,
        pos='top-center',
        line2="#scale[1.5]{A = %.2f #pm %.2f (stat.) #pm %.2f (syst.)}" % (
            measured_asym, measured_asym_errs[lep][0],  measured_asym_errs[lep][1]
        ), nudge_y=0.03
    )
    pmi = PlotMetaInfo(
        'costheta_unfolded',
        '2j1t_mva_loose {0}'.format(channel),
        'weighted to lumi={0}, sf(tchan)={1}'.format(lumi, fitpars[lep]),
        [args.infileMC, args.infileD]
    )

    of.savePlot(canv, pmi)

    ######################
    # Plot the asymmetry #
    ######################
    hi = [pe_asym]
Ejemplo n.º 6
0
    #Draw the stacked histograms
    #----
    stacks_d = OrderedDict(
    )  #<<< need to use OrderedDict to have data drawn last (dict does not preserve order)
    stacks_d["mc"] = [h_mc1, h_mc2,
                      h_mc3]  # <<< order is important here, mc1 is bottom-most
    stacks_d["data"] = [h_d1]
    stacks = plot_hists_stacked(canv,
                                stacks_d,
                                x_label="variable x [GeV]",
                                y_label="",
                                do_log_y=False)

    #Draws the lumi box
    from plots.common.utils import lumi_textbox
    lumibox = lumi_textbox(19432)

    #Draw the legend
    from plots.common.legend import legend
    leg = legend(
        [h_d1, h_mc3, h_mc2, h_mc1
         ],  # <<< need to reverse MC order here, mc3 is top-most
        styles=["p", "f"],
        width=0.25)

    try:
        os.mkdir("muon_out")
    except OSError:
        pass
    canv.SaveAs("muon_out/test.pdf")
Ejemplo n.º 7
0
def plot_fit(var, fitConf, hData, fit_result):
   tdrstyle()
   canvases = []
   infile = "fits/"+var.shortName+"_fit_"+fitConf.name+".root"
   f = TFile(infile)
   
   print fitConf.name
   outfile_name = "fit_plots/"+var.shortName+"_Fit_"+fitConf.name
   
   #print fit_result
   QCDRATE = fit_result.qcd
   QCDRATE_UP = fit_result.qcd + fit_result.qcd_uncert
   QCDRATE_DOWN = fit_result.qcd - fit_result.qcd_uncert
   NONQCDRATE = fit_result.nonqcd
   NONQCDRATE_UP = fit_result.nonqcd + fit_result.nonqcd_uncert
   NONQCDRATE_DOWN = fit_result.nonqcd - fit_result.nonqcd_uncert
   WJETS = fit_result.wjets
   WJETS_UP = fit_result.wjets + fit_result.wjets_uncert
   WJETS_DOWN = fit_result.wjets - fit_result.wjets_uncert
      
   cst = TCanvas("Histogram_"+fitConf.name,fitConf.name,10,10,1000,1000)
   
   hNonQCD = TH1D(f.Get(var.shortName+"__nonqcd"))
   hNonQCD.SetTitle("Non-QCD")   
   hNonQCD.SetLineColor(kRed)
      
   hNonQCDp=TH1D(hNonQCD)
   hNonQCDp.Scale(NONQCDRATE_UP/NONQCDRATE)
   hNonQCDm=TH1D(hNonQCD)
   hNonQCDm.Scale(NONQCDRATE_DOWN/NONQCDRATE)
      
   hNonQCDp.SetLineColor(kOrange)
   hNonQCDp.SetTitle("Non-QCD #pm 1 #sigma")
   hNonQCDm.SetLineColor(kOrange)
   hNonQCDm.SetTitle("non-QCD - 1 sigma")

   hWJets = TH1D(f.Get(var.shortName+"__wjets"))
   hWJets.SetTitle("W+Jets")   
   hWJets.SetLineColor(kGreen+4)
      
   hWJetsp=TH1D(hWJets)
   hWJetsp.Scale(WJETS_UP/WJETS)
   hWJetsm=TH1D(hWJets)
   hWJetsm.Scale(WJETS_DOWN/WJETS)
      
   hWJetsp.SetLineColor(kGreen+8)
   hWJetsp.SetTitle("W+Jets #pm 1 #sigma")
   hWJetsm.SetLineColor(kGreen+8)
   hWJetsm.SetTitle("W+Jets - 1 sigma")
      
   hData.SetNameTitle(var.shortName+"__DATA", "Data")
   hData.SetMarkerStyle(20)

   #print "data integral: ",hData.Integral()
   hQCD = f.Get(var.shortName+"__qcd")
   hQCD.SetNameTitle(var.shortName+"__qcd", "QCD")
   hQCD.SetLineColor(kYellow)
      
   hQCDp=TH1D(hQCD)
   hQCDp.Scale(QCDRATE_UP/QCDRATE)
   hQCDm=TH1D(hQCD)   
   hQCDm.Scale(QCDRATE_DOWN/QCDRATE)
      
   hQCDp.SetLineColor(kGreen)
   hQCDp.SetTitle("QCD #pm 1 #sigma")
   hQCDm.SetLineColor(kGreen)
   hQCDm.SetTitle("QCD #pm 1 #sigma")
      
   hTotal=TH1D(hNonQCD)
   hTotal.Add(hQCD)
   hTotal.Add(hWJets)
   hTotal.SetLineColor(kBlue)
   hTotal.SetTitle("Fitted total")
   max_bin = hData.GetMaximum()*1.6
   hData.SetAxisRange(0, max_bin, "Y")
   hData.GetXaxis().SetTitle(var.displayName)
   #hTotal.Draw("")
   title = fit_result.getTitle()
   hData.SetMarkerStyle(20)
   hData.Draw("E1")
   hNonQCDp.Draw("same")
   hQCD.Draw("same")
   hNonQCD.Draw("same")
   hNonQCDm.Draw("same")
   hQCDp.Draw("same")
   hQCDm.Draw("same")
   hWJets.Draw("same")
   hWJetsp.Draw("same")
   hWJetsm.Draw("same")
   hTotal.Draw("same")
   #hData.SetTitle("QCD fit, "+title)
   hData.Draw("E1 same")

   lumibox = lumi_textbox(19739)

   leg = legend(
        [hData, hQCD, hQCDp, hNonQCD, hNonQCDp, hWJets, hWJetsp, hTotal],
        styles=["p", "l"],
        width=0.2
    ) 

   leg.Draw()
          
   #print hNonQCD.Integral(), hData.Integral(), hQCD.Integral(), hTotal.Integral(), hQCDp.Integral(), hQCDm.Integral()
   cst.Update()
   cst.SaveAs(outfile_name+".png")
   cst.SaveAs(outfile_name+".pdf")
   cst.Draw()
   return cst
Ejemplo n.º 8
0
    
    #Anti-iso region
    for s in systematics:
      if s == "Nominal":
         make_histogram(var, dataGroup, cuts.name, openedFiles, lumis, s, "antiiso", cuts.antiIsoCutsData)

         stack = make_stack(var, cuts.name+s, MCGroups, dataGroup, openedFiles, s, "antiiso", lumis, cuts.antiIsoCutsMC, cuts.antiIsoCutsData, "", cuts.name)
         stacks[var.name+s+"antiiso"] = stack
         
    #print "cuts",cuts.isoCutsData

    tdrstyle.tdrstyle()
    cst = TCanvas("Histogram","Jet Systematics in final selection",10,10,1000,1000)

    lumibox = lumi_textbox(lumi_iso["mu"])    
    histos = []

    hData=dataGroup.getHistogram(var, "Nominal", "iso"+cuts.name)
    #hQCDShapeOrig = dataGroup.getHistogram(var, "Nominal", "antiiso")
    hData.Draw("e1")
    hData.SetMarkerStyle(20)
    hData.SetAxisRange(0,1000,"Y")
    stackSys = THStack("Stacksys", "stackName")
    for s in systematics:
      if s == "Nominal":
         stackNom = stacks[var.name+s+"iso"]
      else:
         for st in syst_type:
            stack = stacks[var.name+s+st+"iso"]              
            h1 = TH1D(var.shortName+"_"+s+st, var.shortName+" "+s+st, var.bins, var.lbound, var.ubound)
Ejemplo n.º 9
0
            \end{tabular}
            \end{center}    
\end{frame}
            """)

            for name,histo in histos[process].items():
                if name != "Nominal":
                    print "Chi2 %s %s %.2f %.3f" %(process,name,histo.Chi2Test(histos[process]["Nominal"], "WW CHI2/NDF"),histo.Chi2Test(histos[process]["Nominal"], "WW"))

            canv = plot_hists(canv, histos[process],
                x_label="cos(#Theta *)",
                title=process,
                max_bin_mult=1.6
            )
            
            #Draws the lumi box
            lumibox = lumi_textbox(lumi_iso["mu"])
            
            #Draw the legend
            leg = legend(
                histos[process].values(), # <<< need to reverse MC order here, mc3 is top-most
                styles=["l"],
                width=0.3,
                text_size=0.015
            )

            outf.write(make_plot_slide(process, canv))

    outf.write("\end{document}")
    outf.close()
Ejemplo n.º 10
0
def data_mc_plot(pd):
    hists = load_theta_format(pd.infile, styles)

    for (variable, sample, systtype, systdir), hist in hists.items_flat():

        #Scale all MC samples except QCD to the luminosity
        if sample_types.is_mc(sample) and not sample=="qcd":
            hist.Scale(pd.lumi)
        if hasattr(pd, "rebin"):
            hist.Rebin(pd.rebin)
        if sample=="qcd" and hasattr(pd, "qcd_yield"):
            hist.Scale(pd.qcd_yield / hist.Integral())

        rescale_to_fit(sample, hist, pd.process_scale_factor)
        hist.SetTitle(sample)
        hist.SetName(sample)


    #Assuming we only have 1 variable
    hists = hists[pd.var]

    hists_nominal = hists.pop("nominal")[None]
    hists_nom_data = hists_nominal.pop('data')
    hists_nom_mc = hists_nominal.values()
    hists_syst = hists

    hists_nom_data.SetTitle('data')

    #A list of all the systematic up, down variation templates as 2-tuples
    all_systs = [
    ]

    all_systs = hists_syst.keys()
    systs_to_consider = []

    #See which systematics where asked to switch on
    for syst in all_systs:
        for sm in pd.systematics:
            if re.match(sm, syst):
                systs_to_consider.append(syst)

    #The total nominal MC histogram
    nom = sum(hists_nom_mc)

    if pd.normalize:
        ratio = hists_nom_data.Integral() / nom.Integral()
        hists_nom_data.Scale(1.0/ratio)

    #Get all the variated up/down total templates
    #A list with all the up/down total templates
    all_systs = []

    sumsqs = []
    logger.info("Considering systematics %s" % str(systs_to_consider))
    for syst in systs_to_consider:

        #A list with the up/down variated template for a particular systematic
        totupdown = []

        sumsq = []
        for systdir in ["up", "down"]:

            #Get all the templates corresponding to a systematic scenario and a variation
            _hists = hists_syst[syst][systdir]


            for k, h in _hists.items():

                """
                Consider only the shape variation of the systematic,
                hence the variated template is normalized to the corresponding
                unvariated template.
                """
                if pd.systematics_shapeonly:
                    if h.Integral()>0:
                        h.Scale(hists_nominal[k].Integral() / h.Integral())

            #For the missing variated templates, use the nominal ones, but warn the user
            present = set(_hists.keys())
            all_mc = set(hists_nominal.keys())
            missing = list(all_mc.difference(present))
            for m in missing:
                logger.warning("Missing systematic template for %s:%s" % (syst, systdir))

            #Calculate the total variated template
            tot = sum(_hists.values()) + sum([hists_nominal[m] for m in missing])
            totupdown.append(tot)

            sumsq.append(
                math.sqrt(numpy.sum(numpy.power(numpy.array(list(nom.y())) - numpy.array(list(tot.y())), 2)))
            )
        logger.debug("Systematic %s: sumsq=%.2Eu, %.2Ed" % (syst, sumsq[0], sumsq[1]))
        sumsqs.append((syst, max(sumsq)))
        all_systs.append(
            (syst, tuple(totupdown))
        )

    sumsqs = sorted(sumsqs, key=lambda x: x[1], reverse=True)
    for syst, sumsq in sumsqs[0:7]:
        logger.info("Systematic %s, %.4f" % (syst, sumsq))

    #Calculate the total up/down variated templates by summing in quadrature
    syst_stat_up, syst_stat_down = total_syst(
        nom, all_systs,
    )

    for k, v in hists_nominal.items():
        if hasattr(PhysicsProcess, k):
            pp = getattr(PhysicsProcess, k)
            v.SetTitle(pp.pretty_name)
        else:
            logger.warning("Not setting pretty name for %s" % k)


    #If QCD is high-stats, put it in the bottom
    plotorder = copy.copy(PhysicsProcess.desired_plot_order_mc)
    if hists_nominal["qcd"].GetEntries()>100:
        plotorder.pop(plotorder.index("qcd"))
        plotorder.insert(0, "qcd")

    stacks_d = OrderedDict()
    stacks_d['mc'] = reorder(hists_nominal, plotorder)
    stacks_d['data'] = [hists_nom_data]

    #Systematic style
    for s in [syst_stat_up, syst_stat_down]:
        s.SetFillStyle(0)
        s.SetLineWidth(3)
        s.SetMarkerSize(0)
        s.SetLineColor(ROOT.kBlue+2)
        s.SetLineStyle('dashed')
        s.SetTitle("stat. + syst.")

    #c = ROOT.TCanvas("c", "c", 1000, 1000)
    c = ROOT.TCanvas("c", "c")
    p1 = ROOT.TPad("p1", "p1", 0, 0.3, 1, 1)
    p1.Draw()
    p1.SetTicks(1, 1);
    p1.SetGrid();
    p1.SetFillStyle(0);
    p1.cd()

    stacks = plot_hists_stacked(
        p1, stacks_d,
        x_label=pd.get_x_label(), max_bin_mult=pd.get_max_bin_mult(),
        min_bin=pd.get_min_bin()
    )
    p1.SetLogy(pd.log)

    syst_stat_up.Draw("SAME hist")
    syst_stat_down.Draw("SAME hist")

    ratio_pad, hratio = plot_data_mc_ratio(
        c, hists_nom_data,
        nom, syst_hists=(syst_stat_down, syst_stat_up), min_max=pd.get_ratio_minmax()
    )



    p1.cd()
    leg = legend(
        stacks_d['data'] +
        list(reversed(stacks_d['mc'])) +
        [syst_stat_up],
        nudge_x=pd.legend_nudge_x,
        nudge_y=pd.legend_nudge_y,
        **pd.__dict__
    )
    lb = lumi_textbox(pd.lumi,
        line2=pd.get_lumibox_comments(channel=pd.channel_pretty),
        pos=pd.get_lumi_pos()
    )
    c.children = [p1, ratio_pad, stacks, leg, lb]

    tot = 0
    for k, v in hists_nominal.items():
        print k, v.Integral(), v.GetEntries()
        tot += v.Integral()
    tot_data = hists_nom_data.Integral()
    print "MC: %.2f Data: %.2f" % (tot, tot_data)
    #import pdb; pdb.set_trace()
    return c, (hists_nominal, hists_nom_data)
Ejemplo n.º 11
0
    #Draw the stacked histograms
    #----
    stacks_d = OrderedDict() #<<< need to use OrderedDict to have data drawn last (dict does not preserve order)
    stacks_d["mc"] = [h_mc1, h_mc2, h_mc3] # <<< order is important here, mc1 is bottom-most
    stacks_d["data"] = [h_d1]
    stacks = plot_hists_stacked(
        canv,
        stacks_d,
        x_label="variable x [GeV]",
        y_label="",
        do_log_y=False
    )

    #Draws the lumi box
    from plots.common.utils import lumi_textbox
    lumibox = lumi_textbox(19432)

    #Draw the legend
    from plots.common.legend import legend
    leg = legend(
        [h_d1, h_mc3, h_mc2, h_mc1], # <<< need to reverse MC order here, mc3 is top-most
        styles=["p", "f"],
        width=0.25
    )

    try:
        os.mkdir("muon_out")
    except OSError:
        pass
    canv.SaveAs("muon_out/test.pdf")
Ejemplo n.º 12
0
            for name, histo in histos[process].items():
                if name != "Nominal":
                    print "Chi2 %s %s %.2f %.3f" % (
                        process, name,
                        histo.Chi2Test(histos[process]["Nominal"],
                                       "WW CHI2/NDF"),
                        histo.Chi2Test(histos[process]["Nominal"], "WW"))

            canv = plot_hists(canv,
                              histos[process],
                              x_label="cos(#Theta *)",
                              title=process,
                              max_bin_mult=1.6)

            #Draws the lumi box
            lumibox = lumi_textbox(lumi_iso["mu"])

            #Draw the legend
            leg = legend(
                histos[process].values(
                ),  # <<< need to reverse MC order here, mc3 is top-most
                styles=["l"],
                width=0.3,
                text_size=0.015)

            outf.write(make_plot_slide(process, canv))

    outf.write("\end{document}")
    outf.close()