ROOT logo
#include <math.h>
#include <time.h>
#include <stdio.h>
#include <stdlib.h>
#include <Riostream.h>

#include "TVector2.h"
#include "TFile.h"
#include "TString.h"
#include "TLatex.h"
#include "TCanvas.h"
#include "TPad.h"
#include "TF1.h"
#include "TH1.h"
#include "TH2.h"
#include "TH3.h"
#include "TProfile.h"
#include "TProfile2D.h"
#include "TMath.h"
#include "TText.h"
#include "TRandom3.h"
#include "TArray.h"
#include "TLegend.h"
#include "TStyle.h"
#include "TMinuit.h"
#include "TASImage.h"
#include "TGraphErrors.h"
#include "TGraphAsymmErrors.h"
#include "TSpline.h"
#include "TMultiGraph.h"

#define BohrR 1963.6885
#define FmToGeV 0.19733 // conversion to fm
#define PI 3.1415926
#define masspiC 0.1395702 // pi+ mass (GeV/c^2)

using namespace std;

bool SaveFiles=kFALSE;
const int KT3Bin=0;// Kt3 bin. 0-1
int FitType=1;// 0 (Gaussian), 1 (Edgeworth), 2 (Exponential)
bool pp_pPb_Comp=0;
bool AddedCC=kTRUE;// Charge Conjugate already added?
bool NchOneThirdAxis=0;
//
int MbinMaxPbPb=15;// 15
int MbinMinpPb=12;// 13
int MbinMinpp=13;// 14 
int MbinMinPbPb=0;// 0
int MbinMaxpPb=18;// 18
//
//
//
const int MaxKT3Bins=2;
int TextFont=42;// 63, or 42
float SizeLabel=0.06;// 20(63 font), 0.08(42 font)
float SizeLegend=0.05;// 
float SizeTitle=0.06;// 
float SizeSpecif=0.05;// 

bool RadiusOnly=0;// only show radii, not lambdas


double RightMargin=0.002;// 0.002
//
double Chi2_C2global;
double NFitPoints_C2global;
TH1D *C2_ss[20];
TH1D *C2_os[20];



void DrawALICELogo(Bool_t, Float_t, Float_t, Float_t, Float_t);
TCanvas *make_canvas(const Char_t*,const Char_t*,Int_t,Int_t,Int_t,Int_t,Int_t);

void Plot_plotsTPR(){

  gStyle->SetOptStat(0);
  gStyle->SetOptDate(0);
  //gStyle->SetOptFit(0111);

  ////////////////////////////////////
  // Get Nrec to Nch mapping
  double meanNchPbPb[20]={0};
  //double meanNchPbPb_e[20]={0};
  double meanNchpPb[20]={0};
  //double meanNchpPb_e[20]={0};
  double meanNchpp[20]={0};
  //double meanNchpp_e[20]={0};
  TFile *NrecMapFile;
  TH2D *NrecMap;
  TList *MyList;
  //
  NrecMapFile = new TFile("Results/NrecMapping_12a17a_NclsFix.root","READ");// standard
  //NrecMapFile = new TFile("Results/NrecMapping_12a17a.root","READ");// v5 and before (with P < 1.0 cut)
  //NrecMapFile = new TFile("Results/NrecMapping_12a17a_TuneOnData.root","READ");
  //NrecMapFile = new TFile("Results/Old_NrecMappingFiles/NrecMapping_12a17a.root","READ");// paper v1 file (without P < 1.0 cut)
  //NrecMapFile = new TFile("Results/NrecMapping_12a11a.root","READ");// MC variation
  MyList=(TList*)NrecMapFile->Get("MyList");
  NrecMap = (TH2D*)MyList->FindObject("fNchTrueDist");// Nch
  //NrecMap = (TH2D*)MyList->FindObject("fNpionTrueDist");// Npions
  for(int bin=1; bin<=2; bin++){// 1 to 2 (FB7),  1 to 1 (AMPT),  1 to 4 (FB5and7overlap)
    NrecMap->GetXaxis()->SetRangeUser(bin,bin);
    if(NrecMap->GetMean(2)>0) {
      meanNchPbPb[bin-1] = NrecMap->GetMean(2);
      //cout<<NrecMap->GetMean(2)<<"  "<<fabs(NrecMap->GetRMS(2))/NrecMap->GetMean(2)<<endl;
    }
    if(NchOneThirdAxis) if(NrecMap->GetMean(2)>0) meanNchPbPb[bin-1] = pow(NrecMap->GetMean(2),1/3.);
  }
  NrecMapFile->Close();
  //
  NrecMapFile = new TFile("Results/NrecMapping_12a17e_NclsFix.root","READ");// standard
  //NrecMapFile = new TFile("Results/NrecMapping_12a17e.root","READ");// v5 and before (with P < 1.0 cut)
  //NrecMapFile = new TFile("Results/NrecMapping_12a17e_TuneOnData.root","READ");
  //NrecMapFile = new TFile("Results/Old_NrecMappingFiles/NrecMapping_12a17e.root","READ");// paper v1 file (without P < 1.0 cut)
  //NrecMapFile = new TFile("Results/NrecMapping_12a11b.root","READ");// MC variation
  MyList=(TList*)NrecMapFile->Get("MyList");
  NrecMap = (TH2D*)MyList->FindObject("fNchTrueDist");
  //NrecMap = (TH2D*)MyList->FindObject("fNpionTrueDist");
  for(int bin=3; bin<=10; bin++){// 3 to 10 (FB7),  2 to 3 (AMPT), 5 to 12 (FB5and7overlap)
    NrecMap->GetXaxis()->SetRangeUser(bin,bin);
    if(NrecMap->GetMean(2)>0) {
      meanNchPbPb[bin-1] = NrecMap->GetMean(2);
      //cout<<NrecMap->GetMean(2)<<"  "<<fabs(NrecMap->GetRMS(2))/NrecMap->GetMean(2)<<endl;
    }
    if(NchOneThirdAxis) if(NrecMap->GetMean(2)>0) meanNchPbPb[bin-1] = pow(NrecMap->GetMean(2),1/3.);
  }
  NrecMapFile->Close();
  //
  ////////////////////// extra for AMPT 
  /*NrecMapFile = new TFile("Results/NrecMapping_12a11d.root","READ");
  MyList=(TList*)NrecMapFile->Get("MyList");
  NrecMap = (TH2D*)MyList->FindObject("fNchTrueDist");
  for(int bin=4; bin<=7; bin++){// 4 to 7 (AMPT)
    NrecMap->GetXaxis()->SetRangeUser(bin,bin);
    if(NrecMap->GetMean(2)>0) meanNchPbPb[bin-1] = log10(NrecMap->GetMean(2));
  }
  NrecMapFile->Close();*/
  //////////////////////////////////////////
  //
  NrecMapFile = new TFile("Results/NrecMapping_12a17c_NclsFix.root","READ");// standard
  //NrecMapFile = new TFile("Results/NrecMapping_12a17c.root","READ");// v5 and before (with P < 1.0 cut)
  //NrecMapFile = new TFile("Results/NrecMapping_12a17c_TuneOnData.root","READ");
  //NrecMapFile = new TFile("Results/Old_NrecMappingFiles/NrecMapping_12a17c.root","READ");// paper v1 file (without P < 1.0 cut)
  //NrecMapFile = new TFile("Results/NrecMapping_12a11g.root","READ");// MC variation
  MyList=(TList*)NrecMapFile->Get("MyList");
  NrecMap = (TH2D*)MyList->FindObject("fNchTrueDist");
  //NrecMap = (TH2D*)MyList->FindObject("fNpionTrueDist");
  for(int bin=11; bin<=19; bin++){// 11 to 19 (FB7),  1 to 1 (AMPT), 13 to 19 (FB5and7overlap)
    NrecMap->GetXaxis()->SetRangeUser(bin,bin);
    if(NrecMap->GetMean(2)>0) {
      meanNchPbPb[bin-1] = NrecMap->GetMean(2);
      //cout<<NrecMap->GetMean(2)<<"  "<<fabs(NrecMap->GetRMS(2))/NrecMap->GetMean(2)<<endl;
    }    
    if(NchOneThirdAxis) if(NrecMap->GetMean(2)>0) meanNchPbPb[bin-1] = pow(NrecMap->GetMean(2),1/3.);
  }
  NrecMapFile->Close();
  ///cout<<endl;
  //
  NrecMapFile = new TFile("Results/NrecMapping_13b2_efix_NclsFix.root","READ");// standard
  //NrecMapFile = new TFile("Results/NrecMapping_13b2_efix_p1.root","READ");// v5 and before (with P < 1.0 cut)
  //NrecMapFile = new TFile("Results/NrecMapping_13b2_TuneOnData.root","READ");
  //NrecMapFile = new TFile("Results/PDC_13b2_efix_p1_R2.root","READ");// paper v1 file (without P < 1.0 cut)
  //NrecMapFile = new TFile("Results/NrecMapping_13b3.root","READ");// MC variation
  MyList=(TList*)NrecMapFile->Get("MyList");
  NrecMap = (TH2D*)MyList->FindObject("fNchTrueDist");
  //NrecMap = (TH2D*)MyList->FindObject("fNpionTrueDist");
  for(int bin=10; bin<=20; bin++){
    NrecMap->GetXaxis()->SetRangeUser(bin,bin);
    if(NrecMap->GetMean(2)>0) {
      meanNchpPb[bin-1] = NrecMap->GetMean(2);
      //cout<<NrecMap->GetMean(2)<<"  "<<fabs(NrecMap->GetRMS(2))/NrecMap->GetMean(2)<<endl;
    }
    if(NchOneThirdAxis) if(NrecMap->GetMean(2)>0) meanNchpPb[bin-1] = pow(NrecMap->GetMean(2),1/3.);
  }
  NrecMapFile->Close();
  //cout<<endl;
  //
  NrecMapFile = new TFile("Results/NrecMapping_10f6a_NclsFix.root","READ");// standard
  //NrecMapFile = new TFile("Results/NrecMapping_10f6a.root","READ");// v5 (with P < 1.0 cut)
  //NrecMapFile = new TFile("Results/NrecMapping_10f6a_TuneOnData.root","READ");
  //NrecMapFile = new TFile("Results/PDC_10f6a_R2.root","READ");// paper v1 file (without P < 1.0 cut)
  //NrecMapFile = new TFile("Results/NrecMapping_10f6.root","READ");// MC variation
  MyList=(TList*)NrecMapFile->Get("MyList");
  NrecMap = (TH2D*)MyList->FindObject("fNchTrueDist");
  //NrecMap = (TH2D*)MyList->FindObject("fNpionTrueDist");
  for(int bin=10; bin<=20; bin++){
    NrecMap->GetXaxis()->SetRangeUser(bin,bin);
    if(NrecMap->GetMean(2)>0) {
      meanNchpp[bin-1] = NrecMap->GetMean(2);
      //cout<<NrecMap->GetMean(2)<<"  "<<fabs(NrecMap->GetRMS(2))/NrecMap->GetMean(2)<<endl;
    }
    if(NchOneThirdAxis) if(NrecMap->GetMean(2)>0) meanNchpp[bin-1] = pow(NrecMap->GetMean(2),1/3.);
  }
  NrecMapFile->Close();
  //cout<<endl;

  //for(int i=0; i<20; i++) cout<<pow(10,meanNchPbPb[i])<<endl;
  //cout<<"+++++++++++++++"<<endl;
  //for(int i=0; i<20; i++) cout<<pow(10,meanNchpPb[i])<<endl;
  //cout<<"+++++++++++++++"<<endl;
  //for(int i=0; i<20; i++) cout<<meanNchpp[i]<<endl;

  TFile *ExRangeFile=new TFile("Results/ExtendedQ3rangeM0.root","READ");
  TList *ExList=(TList*)ExRangeFile->Get("MyList");
  TH1D *ExRangeTerm1=(TH1D*)ExList->FindObject("fExtendedQ3Histo_term1");
  TH1D *ExRangeTerm2=(TH1D*)ExList->FindObject("fExtendedQ3Histo_term2");
  TH1D *ExRangeTerm5=(TH1D*)ExList->FindObject("fExtendedQ3Histo_term5");
  ExRangeTerm1->SetDirectory(0); ExRangeTerm2->SetDirectory(0); ExRangeTerm5->SetDirectory(0);
  ExRangeFile->Close();
  ExRangeTerm1->Sumw2(); ExRangeTerm2->Sumw2(); ExRangeTerm5->Sumw2();
  ExRangeTerm2->Scale(ExRangeTerm1->Integral(25,29)/ExRangeTerm2->Integral(25,29));
  ExRangeTerm5->Scale(ExRangeTerm1->Integral(25,29)/ExRangeTerm5->Integral(25,29));
  float TwoFrac=0.7;
  float OneFrac=pow(TwoFrac,.5); 
  float ThreeFrac=pow(TwoFrac,1.5);
  // Purify.  Isolate pure 3-pion QS correlations using Lambda and K3 (removes lower order correlations)
  ExRangeTerm1->Add(ExRangeTerm5, -(pow(1-OneFrac,3) + 3*OneFrac*pow(1-OneFrac,2))); 
  ExRangeTerm1->Add(ExRangeTerm2, -3*(1-OneFrac));
  ExRangeTerm1->Add(ExRangeTerm5, (1-OneFrac)*3*(1-TwoFrac));
  ExRangeTerm1->Scale(1/ThreeFrac);
  // Isolate 3-pion cumulant
  ExRangeTerm1->Add(ExRangeTerm2, -3/TwoFrac);
  ExRangeTerm1->Add(ExRangeTerm5, 3*(1-TwoFrac)/TwoFrac);
  ExRangeTerm1->Add(ExRangeTerm5, 3);
  ExRangeTerm1->Divide(ExRangeTerm5);
  ExRangeTerm1->SetMarkerStyle(20);
  ExRangeTerm1->SetMarkerColor(1);
  
  //
  TF1 *MixedChargeSysFit=new TF1("MixedChargeSysFit","[0]+[1]*exp(-pow([2]*x/0.19733,2))",0,.5);
  //
  TF1 *Fit_C2[3][3][3][20];// CollType, Gauss/EW/Exp, EDbin, cb
  TH1D *Parameters_C2[3][3][3][6];// CollType, Gauss/EW/Exp, EDbin, Parameter#
  TH1D *C2[3][3][20];// CollType, EDbin, cb
  TH1D *C2_Sys[3][3][20];// CollType, EDbin, cb
  TH1D *C3[3][2][2][3][20];// CollType, Real/MonteCarlo, SC/MC, EDbin, cb
  TH1D *c3[3][2][2][3][20];// CollType, Real/MonteCarlo, SC/MC, EDbin, cb
  TH1D *C3_Sys[3][2][2][3][20];// CollType, Real/MonteCarlo, SC/MC, EDbin, cb
  TH1D *c3_Sys[3][2][2][3][20];// CollType, Real/MonteCarlo, SC/MC, EDbin, cb
  TF1 *c3_fit[3][3][3][20];// CollType, Gauss/EW/Exp, EDbin, cb
  TGraph *gr_c3Spline[3][3][20];// CollType, EDbin, cb
  TGraph *gr_c3SplineExpFit[3][3][20];// CollType, EDbin, cb
  TF1 *c3_mixedChargeSysFit[3][2][20];// CollType, EDbin, cb
  TH1D *Parameters_c3[3][3][3][6];// CollType, Gaussian/EW, EDbin, Parameter#
  TH1D *Parameters_Bjoern[2][3];// Bjoern's points: Hydro case, CollType

  for(int ct=0; ct<3; ct++){
    for(int ft=0; ft<3; ft++){// Gaussian or EW or Exp
      for(int kt3=0; kt3<3; kt3++){
	for(int par=0; par<6; par++){
	  TString *name_C2=new TString("Parameters_C2_");
	  *name_C2 += ct;
	  *name_C2 += ft;
	  *name_C2 += kt3;
	  *name_C2 += par;
	  TString *name_c3=new TString("Parameters_c3_");
	  *name_c3 += ct;
	  *name_c3 += ft;
	  *name_c3 += kt3;
	  *name_c3 += par;
	  
	  if(NchOneThirdAxis) {
	    Parameters_C2[ct][ft][kt3][par] = new TH1D(name_C2->Data(),"",3000,1,13.5);// Nch^(1/3)
	    Parameters_c3[ct][ft][kt3][par] = new TH1D(name_c3->Data(),"",3000,1,13.5);// Nch^(1/3)
	    if(ft==0 && kt3==0 && par==0){
	      TString *name_Bjoern = new TString("Bjoern_"); *name_Bjoern += ct;
	      Parameters_Bjoern[0][ct] = new TH1D(name_Bjoern->Data(),"",3000,1,13.5);// Nch^(1/3)
	      name_Bjoern->Append("_hydro");
	      Parameters_Bjoern[1][ct] = new TH1D(name_Bjoern->Data(),"",3000,1,13.5);// Nch^(1/3)
	    }
	  }else{
	    Parameters_C2[ct][ft][kt3][par] = new TH1D(name_C2->Data(),"",30000,1,3001);// Nch
	    Parameters_c3[ct][ft][kt3][par] = new TH1D(name_c3->Data(),"",30000,1,3001);// Nch
	    if(ft==0 && kt3==0 && par==0){
	      TString *name_Bjoern = new TString("Bjoern_"); *name_Bjoern += ct;
	      Parameters_Bjoern[0][ct] = new TH1D(name_Bjoern->Data(),"",30000,1,3001);// Nch
	      name_Bjoern->Append("_hydro");
	      Parameters_Bjoern[1][ct] = new TH1D(name_Bjoern->Data(),"",30000,1,3001);// Nch
	    }
	  }
	}
      }
    }
  }
  
  TH1D *RadiiC2pp_Published = new TH1D("RadiiC2pp_Published","",3000,1.0,3001);
  //
  double N_1 = 0, N_1_e=0;
  double lambda_1 = 0, lambda_1_e=0;
  double radius_1 = 0, radius_1_e=0;
  double EW1_1 = 0, EW1_1_e=0;
  double EW2_1 = 0, EW2_1_e=0;
  
  
  // Start File access
  for(int ct=0; ct<3; ct++){
    for(int dt=0; dt<2; dt++){// data type (Real or Monte Carlo)
      if(ct==0 && dt==1) continue; // no MC for PbPb
      for(int cb=0; cb<20; cb++){
	if(ct==0 && cb<MbinMinPbPb) continue;
	if(ct==0 && cb>MbinMaxPbPb) continue;
	if(ct==1 && cb>MbinMaxpPb) continue;
	if(ct==1 && cb<MbinMinpPb) continue;
	if(ct==2 && cb<MbinMinpp) continue;
	if(ct==2 && dt==1 && cb<=13) continue;// no Pythia data for cb=13
	for(int ChComb=0; ChComb<2; ChComb++) {// SC or MC
	  for(int ch=0; ch<1; ch++) {// - or +
	    for(int KT3=0; KT3<MaxKT3Bins; KT3++) {// Kt3 bin
	      if(dt==1 && KT3>0) continue;// no MC data yet for higher kt3
	      TString *name3 = new TString("OutFiles/OutFile");
	      if(ct==0) name3->Append("PbPb");
	      if(ct==1) name3->Append("pPb");
	      if(ct==2) name3->Append("pp");
	      if(dt==1) name3->Append("MonteCarlo");
	      if(ChComb==0) name3->Append("SC");
	      else name3->Append("MC");
	      if(ch==0) name3->Append("Neg");
	      else name3->Append("Pos");
	      
	      name3->Append("Kt3_");
	      *name3 += KT3+1;
	      name3->Append("_M");
	      *name3 += cb;
	      name3->Append(".root");
	      
	      TFile *file=new TFile(name3->Data(),"READ");

	      TString *name3_2 = new TString("OutFiles/OutFileExpFit");
	      if(ct==0) name3_2->Append("PbPb");
	      if(ct==1) name3_2->Append("pPb");
	      if(ct==2) name3_2->Append("pp");
	      name3_2->Append("SC");
	      if(ch==0) name3_2->Append("Neg");
	      else name3_2->Append("Pos");
	      
	      name3_2->Append("Kt3_");
	      *name3_2 += KT3+1;
	      name3_2->Append("_M");
	      *name3_2 += cb;
	      name3_2->Append(".root");

	      TFile *fileExpFit=new TFile(name3_2->Data(),"READ");
	      //
	      
	        
	      if(ch==0) {
		C3[ct][dt][ChComb][KT3][cb]=(TH1D*)file->Get("C3");
		C3[ct][dt][ChComb][KT3][cb]->SetDirectory(0);
		C3[ct][dt][ChComb][KT3][cb]->SetMarkerStyle(24+ct); 
		c3[ct][dt][ChComb][KT3][cb]=(TH1D*)file->Get("c3");
		c3[ct][dt][ChComb][KT3][cb]->SetDirectory(0);
		c3[ct][dt][ChComb][KT3][cb]->SetMarkerStyle(20+ct);
		if(dt==1) {c3[ct][dt][ChComb][KT3][cb]->SetMarkerStyle(28);}
		C3[ct][dt][ChComb][KT3][cb]->GetXaxis()->SetRangeUser(0,0.5);
		
		C3[ct][dt][ChComb][KT3][cb]->GetXaxis()->SetRangeUser(0,0.5);
		C3[ct][dt][ChComb][KT3][cb]->GetXaxis()->SetLabelFont(TextFont); C3[ct][dt][ChComb][KT3][cb]->GetYaxis()->SetLabelFont(TextFont); 
		C3[ct][dt][ChComb][KT3][cb]->GetYaxis()->SetTitleFont(TextFont);
		c3[ct][dt][ChComb][KT3][cb]->GetXaxis()->SetRangeUser(0,0.5);
		c3[ct][dt][ChComb][KT3][cb]->GetXaxis()->SetLabelFont(TextFont); c3[ct][dt][ChComb][KT3][cb]->GetYaxis()->SetLabelFont(TextFont); 
		c3[ct][dt][ChComb][KT3][cb]->GetYaxis()->SetTitleFont(TextFont);
		if(ct==0) {
		  C3[ct][dt][ChComb][KT3][cb]->SetMarkerColor(1); C3[ct][dt][ChComb][KT3][cb]->SetLineColor(1);
		  c3[ct][dt][ChComb][KT3][cb]->SetMarkerColor(1); c3[ct][dt][ChComb][KT3][cb]->SetLineColor(1);
		}else if(ct==1){
		  C3[ct][dt][ChComb][KT3][cb]->SetMarkerColor(2); C3[ct][dt][ChComb][KT3][cb]->SetLineColor(2);
		  c3[ct][dt][ChComb][KT3][cb]->SetMarkerColor(2); c3[ct][dt][ChComb][KT3][cb]->SetLineColor(2);
		  if(dt==1) {c3[ct][dt][ChComb][KT3][cb]->SetMarkerColor(1); c3[ct][dt][ChComb][KT3][cb]->SetLineColor(1);}
		}else {
		  C3[ct][dt][ChComb][KT3][cb]->SetMarkerColor(4); C3[ct][dt][ChComb][KT3][cb]->SetLineColor(4);
		  c3[ct][dt][ChComb][KT3][cb]->SetMarkerColor(4); c3[ct][dt][ChComb][KT3][cb]->SetLineColor(4);
		  if(dt==1) {c3[ct][dt][ChComb][KT3][cb]->SetMarkerColor(1); c3[ct][dt][ChComb][KT3][cb]->SetLineColor(1);}
		}
		
		if(dt==0) {
		  if(ChComb==0) {
		    C2[ct][KT3][cb]=(TH1D*)file->Get("C2_ss");
		    Fit_C2[ct][0][KT3][cb]=(TF1*)file->Get("fitC2ss_Base");// was fitC2ss_Gauss
		    Fit_C2[ct][1][KT3][cb]=(TF1*)file->Get("fitC2ss_Expan");// fitC2ss_EW
		    Fit_C2[ct][2][KT3][cb]=(TF1*)fileExpFit->Get("fitC2ss_Base");// Exp fit

		    C2_Sys[ct][KT3][cb]=(TH1D*)C2[ct][KT3][cb]->Clone();
		    if(ct==0){
		      C2[ct][KT3][cb]->SetMarkerColor(1); C2[ct][KT3][cb]->SetLineColor(1);
		      C2_Sys[ct][KT3][cb]->SetFillColor(kGray);
		    }else if(ct==1){
		      C2[ct][KT3][cb]->SetMarkerColor(2); C2[ct][KT3][cb]->SetLineColor(2);
		      C2_Sys[ct][KT3][cb]->SetFillColor(kRed-10);
		    }else{
		      C2[ct][KT3][cb]->SetMarkerColor(4); C2[ct][KT3][cb]->SetLineColor(4);
		      C2_Sys[ct][KT3][cb]->SetFillColor(kBlue-10);
		    }
		    C2_Sys[ct][KT3][cb]->SetMarkerSize(0); C2_Sys[ct][KT3][cb]->SetFillStyle(1000);
		    // C2 Systematics
		    for(int bin=1; bin<=C2_Sys[ct][KT3][cb]->GetNbinsX(); bin++){
		      C2_Sys[ct][KT3][cb]->SetBinError(bin, 0.01*C2_Sys[ct][KT3][cb]->GetBinContent(bin));
		    }
		    C2[ct][KT3][cb]->SetDirectory(0); //Fit_h_C2[ct][KT3][cb]->SetDirectory(0);
		    C2_Sys[ct][KT3][cb]->SetDirectory(0);
		    C2[ct][KT3][cb]->SetMarkerStyle(24+ct);
		    C2[ct][KT3][cb]->GetXaxis()->SetRangeUser(0,0.33);
		    C2[ct][KT3][cb]->GetXaxis()->SetLabelFont(TextFont); C2[ct][KT3][cb]->GetYaxis()->SetLabelFont(TextFont); 
		    C2[ct][KT3][cb]->GetXaxis()->SetTitleOffset(1.2); C2[ct][KT3][cb]->GetYaxis()->SetTitleOffset(1.2);
		    C2[ct][KT3][cb]->GetXaxis()->SetTitleFont(TextFont); C2[ct][KT3][cb]->GetYaxis()->SetTitleFont(TextFont);
		    C2[ct][KT3][cb]->GetXaxis()->SetTitleSize(SizeTitle); //C2[ct][KT3][cb]->GetYaxis()->SetTitleFont(SizeTitle*SF2);
		    //
		    
		    c3_fit[ct][0][KT3][cb]=(TF1*)file->Get("c3Fit1D_Base");// was c3Fit1D_Gauss
		    c3_fit[ct][1][KT3][cb]=(TF1*)file->Get("c3Fit1D_Expan");// was c3Fit1D_EW
		    c3_fit[ct][2][KT3][cb]=(TF1*)fileExpFit->Get("c3Fit1D_Base");
		    gr_c3Spline[ct][KT3][cb] = (TGraph*)file->Get("gr_c3Spline");// Spline of a spline + TF1
		    gr_c3SplineExpFit[ct][KT3][cb] = (TGraph*)fileExpFit->Get("gr_c3Spline");// Exp fit
		    c3_fit[ct][0][KT3][cb]->SetLineStyle(6);
		    gr_c3Spline[ct][KT3][cb]->SetLineStyle(7); c3_fit[ct][1][KT3][cb]->SetLineStyle(7);
		    gr_c3SplineExpFit[ct][KT3][cb]->SetLineStyle(1); c3_fit[ct][2][KT3][cb]->SetLineStyle(1);
		    if(ct==0) {c3_fit[ct][0][KT3][cb]->SetLineColor(1); c3_fit[ct][1][KT3][cb]->SetLineColor(1); c3_fit[ct][2][KT3][cb]->SetLineColor(1);}
		    if(ct==1) {c3_fit[ct][0][KT3][cb]->SetLineColor(2); c3_fit[ct][1][KT3][cb]->SetLineColor(2); c3_fit[ct][2][KT3][cb]->SetLineColor(2);}
		    if(ct==2) {c3_fit[ct][0][KT3][cb]->SetLineColor(4); c3_fit[ct][1][KT3][cb]->SetLineColor(4); c3_fit[ct][2][KT3][cb]->SetLineColor(4);}
		  }// ChComb==0
		  
		}
	      }else{
		
		if(ChComb==0){
		  N_1 = 0; N_1_e=0;
		  lambda_1 = 0; lambda_1_e=0;
		  radius_1 = 0; radius_1_e=0;
		  EW1_1 = 0; EW1_1_e=0;
		  EW2_1 = 0; EW2_1_e=0;
		  //
		  if(!AddedCC){
		    cout<<"Not Supported!!"<<endl;
		  }
		}
		//
		if(!AddedCC){
		  cout<<"Not Supported!!"<<endl;
		}
	      }// ch==1
	   
	      
	      for(int bin=1; bin<10; bin++){// Remove large error bins
		if(C3[ct][dt][ChComb][KT3][cb]->GetBinError(bin) > 0.33*C3[ct][dt][ChComb][KT3][cb]->GetBinContent(bin)){
		  C3[ct][dt][ChComb][KT3][cb]->SetBinContent(bin,10); C3[ct][dt][ChComb][KT3][cb]->SetBinError(bin,10);
		}
		if(c3[ct][dt][ChComb][KT3][cb]->GetBinError(bin) > 0.33*c3[ct][dt][ChComb][KT3][cb]->GetBinContent(bin)){
		  c3[ct][dt][ChComb][KT3][cb]->SetBinContent(bin,10); c3[ct][dt][ChComb][KT3][cb]->SetBinError(bin,10);
		}
		
	      }
	     
	      if(AddedCC && dt==0){
		if(ct==0 || ct==1) c3[ct][dt][ChComb][KT3][cb]->SetMarkerSize(1.12*C3[ct][dt][ChComb][KT3][cb]->GetMarkerSize());
		else c3[ct][dt][ChComb][KT3][cb]->SetMarkerSize(1.2*C3[ct][dt][ChComb][KT3][cb]->GetMarkerSize());
	
		//
		if(ChComb==0){
		  double logNch=0;
		  if(ct==0) logNch=meanNchPbPb[cb];
		  else if(ct==1) logNch=meanNchpPb[cb];
		  else logNch=meanNchpp[cb];
		  int logNchBin = Parameters_c3[ct][0][KT3][0]->GetXaxis()->FindBin(logNch);
		  for(int ft=0; ft<3; ft++){// Gaussian or EW or Exp
		    N_1 = c3_fit[ct][ft][KT3][cb]->GetParameter(0); N_1_e = c3_fit[ct][ft][KT3][cb]->GetParError(0);
		    lambda_1 = c3_fit[ct][ft][KT3][cb]->GetParameter(1); lambda_1_e = c3_fit[ct][ft][KT3][cb]->GetParError(1);
		    radius_1 = c3_fit[ct][ft][KT3][cb]->GetParameter(2); radius_1_e = c3_fit[ct][ft][KT3][cb]->GetParError(2);
		    if(ft==2) {radius_1 /= sqrt(TMath::Pi()); radius_1_e /= sqrt(TMath::Pi());}
		    EW1_1 = c3_fit[ct][ft][KT3][cb]->GetParameter(3); EW1_1_e = c3_fit[ct][ft][KT3][cb]->GetParError(3);
		    EW2_1 = c3_fit[ct][ft][KT3][cb]->GetParameter(4); EW2_1_e = c3_fit[ct][ft][KT3][cb]->GetParError(4);
		    
		    if(ft!=1) {EW1_1=0; EW2_1=0; EW1_1_e=0; EW2_1_e=0;}// make sure they are zero
		    //
		    Parameters_c3[ct][ft][KT3][0]->SetBinContent(logNchBin, N_1); Parameters_c3[ct][ft][KT3][0]->SetBinError(logNchBin, N_1_e);
		    Parameters_c3[ct][ft][KT3][1]->SetBinContent(logNchBin, lambda_1); Parameters_c3[ct][ft][KT3][1]->SetBinError(logNchBin, lambda_1_e);
		    Parameters_c3[ct][ft][KT3][2]->SetBinContent(logNchBin, radius_1); Parameters_c3[ct][ft][KT3][2]->SetBinError(logNchBin, radius_1_e);
		    Parameters_c3[ct][ft][KT3][3]->SetBinContent(logNchBin, EW1_1); Parameters_c3[ct][ft][KT3][3]->SetBinError(logNchBin, EW1_1_e);
		    Parameters_c3[ct][ft][KT3][4]->SetBinContent(logNchBin, EW2_1); Parameters_c3[ct][ft][KT3][4]->SetBinError(logNchBin, EW2_1_e);
		    // lambda_3* parameter
		    Parameters_c3[ct][ft][KT3][5]->SetBinContent(logNchBin, lambda_1*pow(1 + EW2_1/8.,3));
		    Parameters_c3[ct][ft][KT3][5]->SetBinError(logNchBin, lambda_1_e*pow(1 + EW2_1/8.,3));
		    // remove unstable c3 Fit points
		    bool badbin=kFALSE;
		    if(ct==0 && cb>12) badbin=kTRUE; 
		    if(ct==1 && cb<12) badbin=kTRUE; 
		    if(ct==2 && cb<14) badbin=kTRUE;
		    if(badbin){
		      Parameters_c3[ct][ft][KT3][0]->SetBinContent(logNchBin, 100); Parameters_c3[ct][ft][KT3][0]->SetBinError(logNchBin, 100);
		      Parameters_c3[ct][ft][KT3][1]->SetBinContent(logNchBin, 100); Parameters_c3[ct][ft][KT3][1]->SetBinError(logNchBin, 100);
		      Parameters_c3[ct][ft][KT3][2]->SetBinContent(logNchBin, 100); Parameters_c3[ct][ft][KT3][2]->SetBinError(logNchBin, 100);
		      Parameters_c3[ct][ft][KT3][3]->SetBinContent(logNchBin, 100); Parameters_c3[ct][ft][KT3][3]->SetBinError(logNchBin, 100);
		      Parameters_c3[ct][ft][KT3][4]->SetBinContent(logNchBin, 100); Parameters_c3[ct][ft][KT3][4]->SetBinError(logNchBin, 100);
		      Parameters_c3[ct][ft][KT3][5]->SetBinContent(logNchBin, 100); Parameters_c3[ct][ft][KT3][5]->SetBinError(logNchBin, 100);
		    }
		    //
		    Parameters_C2[ct][ft][KT3][0]->SetBinContent(logNchBin, Fit_C2[ct][ft][KT3][cb]->GetParameter(0));// N
		    Parameters_C2[ct][ft][KT3][0]->SetBinError(logNchBin, Fit_C2[ct][ft][KT3][cb]->GetParError(0));
		    Parameters_C2[ct][ft][KT3][1]->SetBinContent(logNchBin, Fit_C2[ct][ft][KT3][cb]->GetParameter(1));// lambda
		    Parameters_C2[ct][ft][KT3][1]->SetBinError(logNchBin, Fit_C2[ct][ft][KT3][cb]->GetParError(1));
		    radius_1 = Fit_C2[ct][ft][KT3][cb]->GetParameter(3); radius_1_e = Fit_C2[ct][ft][KT3][cb]->GetParError(3);
		    if(ft==2) {radius_1 /= sqrt(TMath::Pi()); radius_1_e /= sqrt(TMath::Pi());}
		    Parameters_C2[ct][ft][KT3][2]->SetBinContent(logNchBin, radius_1);// R
		    Parameters_C2[ct][ft][KT3][2]->SetBinError(logNchBin, radius_1_e);
		    Parameters_C2[ct][ft][KT3][3]->SetBinContent(logNchBin, Fit_C2[ct][ft][KT3][cb]->GetParameter(5));// kappa3
		    Parameters_C2[ct][ft][KT3][3]->SetBinError(logNchBin, Fit_C2[ct][ft][KT3][cb]->GetParError(5));
		    Parameters_C2[ct][ft][KT3][4]->SetBinContent(logNchBin, Fit_C2[ct][ft][KT3][cb]->GetParameter(6));// kappa4
		    Parameters_C2[ct][ft][KT3][4]->SetBinError(logNchBin, Fit_C2[ct][ft][KT3][cb]->GetParError(6));
		    // lambda_* parameter
		    Parameters_C2[ct][ft][KT3][5]->SetBinContent(logNchBin, Fit_C2[ct][ft][KT3][cb]->GetParameter(1)*pow(1 + EW2_1/8.,2));
		    Parameters_C2[ct][ft][KT3][5]->SetBinError(logNchBin, Fit_C2[ct][ft][KT3][cb]->GetParError(1)*pow(1 + EW2_1/8.,2));
		  }// ft
		}// ChComb==0
		//
		// Sys errors
		C3_Sys[ct][0][ChComb][KT3][cb] = (TH1D*)C3[ct][0][ChComb][KT3][cb]->Clone();
		c3_Sys[ct][0][ChComb][KT3][cb] = (TH1D*)c3[ct][0][ChComb][KT3][cb]->Clone();
		if(ct==0){
		  C3_Sys[ct][0][ChComb][KT3][cb]->SetMarkerSize(0); C3_Sys[ct][0][ChComb][KT3][cb]->SetFillStyle(1000); C3_Sys[ct][0][ChComb][KT3][cb]->SetFillColor(kGray);
		  c3_Sys[ct][0][ChComb][KT3][cb]->SetMarkerSize(0); c3_Sys[ct][0][ChComb][KT3][cb]->SetFillStyle(1000); c3_Sys[ct][0][ChComb][KT3][cb]->SetFillColor(kGray);
		}else if(ct==1){
		  C3_Sys[ct][0][ChComb][KT3][cb]->SetMarkerSize(0); C3_Sys[ct][0][ChComb][KT3][cb]->SetFillStyle(1000); C3_Sys[ct][0][ChComb][KT3][cb]->SetFillColor(kRed-10);
		  c3_Sys[ct][0][ChComb][KT3][cb]->SetMarkerSize(0); c3_Sys[ct][0][ChComb][KT3][cb]->SetFillStyle(1000); c3_Sys[ct][0][ChComb][KT3][cb]->SetFillColor(kRed-10);
		}else {
		  C3_Sys[ct][0][ChComb][KT3][cb]->SetMarkerSize(0); C3_Sys[ct][0][ChComb][KT3][cb]->SetFillStyle(1000); C3_Sys[ct][0][ChComb][KT3][cb]->SetFillColor(kBlue-10);
		  c3_Sys[ct][0][ChComb][KT3][cb]->SetMarkerSize(0); c3_Sys[ct][0][ChComb][KT3][cb]->SetFillStyle(1000); c3_Sys[ct][0][ChComb][KT3][cb]->SetFillColor(kBlue-10);
		}
		
		if(ChComb==1){
		  MixedChargeSysFit->SetParameter(0,1);
		  MixedChargeSysFit->SetParameter(1,.1);
		  MixedChargeSysFit->SetParameter(2,1);
		  c3[ct][0][ChComb][KT3][cb]->Fit(MixedChargeSysFit,"IMNQ","",0.01,0.5);
		  c3_mixedChargeSysFit[ct][KT3][cb] = (TF1*)MixedChargeSysFit->Clone();
		  for(int i=1; i<=c3[ct][0][ChComb][KT3][cb]->GetNbinsX(); i++) {
		    float Q3=(i-0.5)*0.01;
		    // SameCharge
		    C3_Sys[ct][0][0][KT3][cb]->SetBinError(i, 0.01 * C3_Sys[ct][0][0][KT3][cb]->GetBinContent(i));
		    c3_Sys[ct][0][0][KT3][cb]->SetBinError(i, sqrt(pow(MixedChargeSysFit->Eval(Q3)-1.0,2) + pow(0.1*(c3_Sys[ct][0][0][KT3][cb]->GetBinContent(i)-1.0),2)));// residue + lambda undilution variation (0.7 to 0.65)
		    // MixedCharge
		    C3_Sys[ct][0][1][KT3][cb]->SetBinError(i, 0.01 * C3_Sys[ct][0][1][KT3][cb]->GetBinContent(i));// correlation function uncertainty
		    c3_Sys[ct][0][1][KT3][cb]->SetBinError(i, sqrt(pow(0.01 * c3_Sys[ct][0][1][KT3][cb]->GetBinContent(i),2) + pow(0.1*(c3_Sys[ct][0][1][KT3][cb]->GetBinContent(i)-1.0),2)));// correlation function uncertainty + lambda undilution variation (0.7 to 0.65)
		  }
		}
		C3_Sys[ct][0][ChComb][KT3][cb]->SetDirectory(0); c3_Sys[ct][0][ChComb][KT3][cb]->SetDirectory(0);
	      }// AddedCC and dt==0
	      
	      file->Close();
	      fileExpFit->Close();
	       
	      
	    }// Kt3
	  }// ch
	}// ChComb
	
      }// cb
      
      if(dt==0){
	for(int ft=0; ft<3; ft++){// Gaussian or EW or Exp
	  for(int KT3=0; KT3<3; KT3++){
	    for(int par=0; par<6; par++){
	      if(ct<2){
		Parameters_C2[ct][ft][KT3][par]->SetMarkerStyle(24+ct);
		Parameters_c3[ct][ft][KT3][par]->SetMarkerStyle(20+ct);
	      }else{
		Parameters_C2[ct][ft][KT3][par]->SetMarkerStyle(28);
		Parameters_c3[ct][ft][KT3][par]->SetMarkerStyle(34);
		RadiiC2pp_Published->SetMarkerStyle(28);
	      }
	      
	      if(ct==0){
		Parameters_C2[ct][ft][KT3][par]->SetMarkerColor(1); 
		Parameters_C2[ct][ft][KT3][par]->SetLineColor(1);
		Parameters_c3[ct][ft][KT3][par]->SetMarkerColor(1); 
		Parameters_c3[ct][ft][KT3][par]->SetLineColor(1);
	      }else if(ct==1){
		Parameters_C2[ct][ft][KT3][par]->SetMarkerColor(2); 
		Parameters_C2[ct][ft][KT3][par]->SetLineColor(2);
		Parameters_c3[ct][ft][KT3][par]->SetMarkerColor(2); 
		Parameters_c3[ct][ft][KT3][par]->SetLineColor(2);
	      }else {
		Parameters_C2[ct][ft][KT3][par]->SetMarkerColor(4); 
		Parameters_C2[ct][ft][KT3][par]->SetLineColor(4);
		Parameters_c3[ct][ft][KT3][par]->SetMarkerColor(4); 
		Parameters_c3[ct][ft][KT3][par]->SetLineColor(4);
		RadiiC2pp_Published->SetMarkerColor(4);
		RadiiC2pp_Published->SetLineColor(4);
	      }
	      
	      if(par==0) Parameters_c3[ct][ft][KT3][par]->GetYaxis()->SetTitle("N");
	      if(par==1) Parameters_c3[ct][ft][KT3][par]->GetYaxis()->SetTitle("#lambda_{e} or #lambda_{e,3}");
	      if(par==2) {
		if(FitType==0) Parameters_c3[ct][ft][KT3][par]->GetYaxis()->SetTitle("#font[12]{R}_{inv,2} or #font[12]{R}_{inv,3} (fm)");
		else if(FitType==1) Parameters_c3[ct][ft][KT3][par]->GetYaxis()->SetTitle("#font[12]{R^{E_{w}}}_{inv,2} or #font[12]{R^{E_{w}}}_{inv,3} (fm)");
		else Parameters_c3[ct][ft][KT3][par]->GetYaxis()->SetTitle("#font[12]{R}^{Exp}_{inv,2} or #font[12]{R}^{Exp}_{inv,3} (fm)");
	      }		
	      if(par==3) Parameters_c3[ct][ft][KT3][par]->GetYaxis()->SetTitle("#kappa_{3}");
	      if(par==4) Parameters_c3[ct][ft][KT3][par]->GetYaxis()->SetTitle("#kappa_{4}");
	      if(par==5) Parameters_c3[ct][ft][KT3][par]->GetYaxis()->SetTitle("#lambda^{#font[12]{G}}_{e} or #lambda^{#font[12]{G}}_{e,3}");
	      if(NchOneThirdAxis) Parameters_c3[ct][ft][KT3][par]->GetXaxis()->SetTitle("N_{ch}^{1/3}");
	      else Parameters_c3[ct][ft][KT3][par]->GetXaxis()->SetTitle("#LT#font[12]{N}_{ch}#GT");
	    }// par
	  }// KT3
	}// ft
      }// dt==0 
      
    }// dt
  }// ct
  
  cout<<"Done Getting Histograms"<<endl;
  
  TF1 *Unity = new TF1("Unity","1",0,100);
  Unity->SetLineStyle(2);
  Unity->SetLineColor(1);
  
 
  /////////////////////////////////////
  // Bjoern's points
  double Bjoern_xaxis_pp[4] = {4.1, 9.2, 16, 26};// Nch
  double Bjoern_Ri_pp[2][4] = {{0.87, 1.09, 1.22, 1.33},{0.837, 0.97, 1.03, 1.18}};// m01 or m02 (infrared cutoff of calc), Nch
  double Bjoern_Rhydro_pp[2][4] = {{0.87, 1.11, 1.35, 1.57},{0.845, 1.04, 1.22, 1.56}};// m01 or m02 (infrared cutoff of calc), Nch
  //
  double Bjoern_xaxis_pPb[6] = {5, 11, 20, 32, 45, 69};// Nch
  double Bjoern_Ri_pPb[2][6] = {{0.98, 1.27, 1.46, 1.59, 1.75, 2},{0.96, 1.18, 1.28, 1.36, 1.44, 1.56}};
  double Bjoern_Rhydro_pPb[2][6] = {{0.98, 1.28, 1.62, 1.96, 2.32, 2.79},{0.96, 1.22, 1.5, 1.76, 2.09, 2.58}};
  //
  double Bjoern_xaxis_PbPb[10] = {22, 36, 50, 77, 98, 137, 172, 326, 498, 760};// Nch
  double Bjoern_Ri_PbPb[2][10] = {{1.6, 2.05, 2.47, 2.86, 3.17, 3.52, 3.88, 4.54, 5.19, 5.85},{1.57, 1.87, 2.27, 2.65, 3, 3.3, 3.52, 4.17, 4.82, 5.49}};
  double Bjoern_Rhydro_PbPb[2][10] = {{1.6, 2.06, 2.49, 2.88, 3.27, 3.63, 4.03, 4.91, 5.88, 6.88},{1.57, 1.88, 2.32, 2.75, 3.14, 3.53, 3.84, 4.65, 5.52, 6.4}};
  //
  int mchoice = 1;// 1 or 2 indicating Bjoern's cutoff
  double SF_Bjoern = 1.15;// 1.15 (m=0.1)
  //


  for(int index=0; index<4; index++){// pp
    for(int m=0; m<2; m++) {Bjoern_Ri_pp[m][index] *= SF_Bjoern; Bjoern_Rhydro_pp[m][index] *= SF_Bjoern;} 
    double xpoint = Bjoern_xaxis_pp[index];
    if(NchOneThirdAxis) xpoint = pow(Bjoern_xaxis_pp[index], 1/3.);
    int bin = Parameters_Bjoern[0][2]->GetXaxis()->FindBin(xpoint);
    Parameters_Bjoern[0][2]->SetBinContent(bin, Bjoern_Ri_pp[mchoice-1][index]);
    Parameters_Bjoern[0][2]->SetBinError(bin, 0.001);
    Parameters_Bjoern[1][2]->SetBinContent(bin, Bjoern_Rhydro_pp[mchoice-1][index]);
    Parameters_Bjoern[1][2]->SetBinError(bin, 0.001);
  }
  for(int index=0; index<6; index++){// pPb
    for(int m=0; m<2; m++) {Bjoern_Ri_pPb[m][index] *= SF_Bjoern; Bjoern_Rhydro_pPb[m][index] *= SF_Bjoern;} 
    double xpoint = Bjoern_xaxis_pPb[index];
    if(NchOneThirdAxis) xpoint = pow(Bjoern_xaxis_pPb[index], 1/3.);
    int bin = Parameters_Bjoern[0][1]->GetXaxis()->FindBin(xpoint);
    Parameters_Bjoern[0][1]->SetBinContent(bin, Bjoern_Ri_pPb[mchoice-1][index]);
    Parameters_Bjoern[0][1]->SetBinError(bin, 0.001);
    Parameters_Bjoern[1][1]->SetBinContent(bin, Bjoern_Rhydro_pPb[mchoice-1][index]);
    Parameters_Bjoern[1][1]->SetBinError(bin, 0.001);
  }
  for(int index=0; index<10; index++){// PbPb
    for(int m=0; m<2; m++) {Bjoern_Ri_PbPb[m][index] *= SF_Bjoern; Bjoern_Rhydro_PbPb[m][index] *= SF_Bjoern;}
    double xpoint = Bjoern_xaxis_PbPb[index];
    if(NchOneThirdAxis) xpoint = pow(Bjoern_xaxis_PbPb[index], 1/3.);
    int bin = Parameters_Bjoern[0][0]->GetXaxis()->FindBin(xpoint);
    Parameters_Bjoern[0][0]->SetBinContent(bin, Bjoern_Ri_PbPb[mchoice-1][index]);
    Parameters_Bjoern[0][0]->SetBinError(bin, 0.001);
    Parameters_Bjoern[1][0]->SetBinContent(bin, Bjoern_Rhydro_PbPb[mchoice-1][index]);
    Parameters_Bjoern[1][0]->SetBinError(bin, 0.001);
  }
  Parameters_Bjoern[0][0]->SetMarkerColor(1); Parameters_Bjoern[0][0]->SetMarkerStyle(20);
  Parameters_Bjoern[0][1]->SetMarkerColor(2); Parameters_Bjoern[0][1]->SetMarkerStyle(21);
  Parameters_Bjoern[0][2]->SetMarkerColor(4); Parameters_Bjoern[0][2]->SetMarkerStyle(34);
  //
  Parameters_Bjoern[1][0]->SetMarkerColor(1); Parameters_Bjoern[1][0]->SetMarkerStyle(20);
  Parameters_Bjoern[1][1]->SetMarkerColor(2); Parameters_Bjoern[1][1]->SetMarkerStyle(21);
  Parameters_Bjoern[1][2]->SetMarkerColor(4); Parameters_Bjoern[1][2]->SetMarkerStyle(34);

  ////////////////////////////////////////////////////
  ////////////////////////////////////////////////////
  // Progaganda Plot
  /*
  TCanvas *can2 = new TCanvas("can2", "can2",10,0,600,600);// 11,53,700,500
  can2->SetHighLightColor(2);
  gStyle->SetOptFit(0111);
  can2->SetFillColor(0);//10
  can2->SetBorderMode(0);
  can2->SetBorderSize(2);
  can2->SetFrameFillColor(0);
  can2->SetFrameBorderMode(0);
  can2->SetFrameBorderMode(0);
  can2->cd();
  TPad *pad2 = new TPad("pad2","pad2",0.0,0.0,1.,1.);
  gPad->SetGridx(0);
  gPad->SetGridy(0);
  gPad->SetTickx(1);
  gPad->SetTicky(1);
  pad2->SetTopMargin(0.02);//0.05
  pad2->SetRightMargin(0.01);//3e-2
  pad2->SetBottomMargin(0.07);//0.12
  pad2->Draw();
  pad2->cd();
  TLegend *legend3 = new TLegend(.35,.75, .94,.95,NULL,"brNDC");//.45 or .4 for x1
  legend3->SetBorderSize(0);
  legend3->SetFillColor(0);
  legend3->SetTextFont(TextFont);
  legend3->SetTextSize(SizeLegend);

  gPad->SetRightMargin(0.03); gPad->SetLeftMargin(0.12);
  gPad->SetBottomMargin(0.1); gPad->SetTopMargin(0.02);
  gPad->SetTickx(1);
  gPad->SetTicky(1);
  int Mb_pp=18;
  int Mb_pPb=13;
  int Mb_PbPb=0;
  c3[2][0][0][0][Mb_pp]->GetXaxis()->SetLabelSize(SizeLabel); c3[2][0][0][0][Mb_pp]->GetYaxis()->SetLabelSize(SizeLabel);
  c3[2][0][0][0][Mb_pp]->GetXaxis()->SetNdivisions(808);
  //
  c3[2][0][0][0][Mb_pp]->GetYaxis()->SetTitle("#font[12]{#bf{c}}_{3}");
  c3[2][0][0][0][Mb_pp]->GetXaxis()->SetTitle("#font[12]{Q}_{3} (GeV/#font[12]{c})");
  c3[2][0][0][0][Mb_pp]->GetYaxis()->SetTitleOffset(1.1);
  c3[2][0][0][0][Mb_pp]->GetYaxis()->SetTitleSize(0.05);
  c3[2][0][0][0][Mb_pp]->SetMinimum(0.9);
  c3[2][0][0][0][Mb_pp]->Draw();
  //legend3->AddEntry(c3[2][0][0][Mb_pp],"N_{ch} = 9#pm0.2, pp #sqrt{s}=7 TeV","p");
  //legend3->AddEntry(c3[1][0][0][Mb_pPb],"N_{ch} = 59#pm2, p-Pb #sqrt{#font[12]{s}_{NN}}=5.02 TeV","p");
  //legend3->AddEntry(c3[0][0][0][Mb_PbPb],"N_{ch} = 1922#pm135, Pb-Pb #sqrt{#font[12]{s}_{NN}}=2.76 TeV","p");
  legend3->AddEntry(c3[2][0][0][0][Mb_pp],"Low N_{ch}, pp #sqrt{#font[12]{s}}=7 TeV","p");
  legend3->AddEntry(c3[1][0][0][0][Mb_pPb],"Mid N_{ch}, p-Pb #sqrt{#font[12]{#font[12]{s}_{NN}}}=5.02 TeV","p");
  legend3->AddEntry(c3[0][0][0][0][Mb_PbPb],"High N_{ch}, Pb-Pb #sqrt{#font[12]{#font[12]{s}_{NN}}}=2.76 TeV","p");
  //
  //TH1D *FillerHist = new TH1D("FillerHist","",50,0,0.5);
  for(int i=1; i<=50; i++) {
    if(i<13) {
      ExRangeTerm1->SetBinContent(i,10.0);
      //FillerHist->SetBinContent(i,10.0); FillerHist->SetBinError(i,.0001);
    }else {
      //FillerHist->SetBinContent(i,1.0); FillerHist->SetBinError(i,.0001);
      c3[0][0][0][0][Mb_PbPb]->SetBinContent(i,10.0);
      c3_Sys[0][0][0][0][Mb_PbPb]->SetBinContent(i,10.0);
    }
  }
  //FillerHist->SetMarkerStyle(24);
  //
  c3_Sys[2][0][0][0][Mb_pp]->Draw("E2 same");
  c3_Sys[1][0][0][0][Mb_pPb]->Draw("E2 same");
  c3_Sys[0][0][0][0][Mb_PbPb]->Draw("E2 same");
  c3[2][0][0][0][Mb_pp]->Draw("same");
  c3[1][0][0][0][Mb_pPb]->Draw("same");
  c3[0][0][0][0][Mb_PbPb]->Draw("same");
  //FillerHist->Draw("same");
  ExRangeTerm1->Draw("same");
  
  TLatex *Specif_Kt3_1 = new TLatex(0.5,0.59,"0.16<#font[12]{K}_{T,3}<1.0 GeV/#font[12]{c}");
  Specif_Kt3_1->SetNDC();
  Specif_Kt3_1->SetTextFont(TextFont);
  Specif_Kt3_1->SetTextSize(SizeSpecif);
  Specif_Kt3_1->Draw("same");
  TLatex *Specif_Kinematics_1 = new TLatex(0.5,0.52,"|#eta|<0.8, 0.16<#font[12]{p}_{T}<1.0 GeV/#font[12]{c}");
  Specif_Kinematics_1->SetNDC();
  Specif_Kinematics_1->SetTextFont(TextFont);
  Specif_Kinematics_1->SetTextSize(SizeSpecif);
  Specif_Kinematics_1->Draw("same");
  TLatex *Species_1 = new TLatex(0.5,0.45,"#pi^{+}#pi^{+}#pi^{+} & #pi^{-}#pi^{-}#pi^{-} combined");
  Species_1->SetNDC();
  Species_1->SetTextFont(TextFont);
  Species_1->SetTextSize(SizeSpecif);
  Species_1->Draw("same");

  legend3->Draw("same");
  DrawALICELogo(kTRUE, .75, .25, .9, .4);

  if(SaveFiles) can2->SaveAs("ThreePionCorrelation_Evolution.eps");
  */


  
  ////////////////////////////////////////////////////
  ////////////////////////////////////////////////////
  // K0s removal plot
  TCanvas *can1 = new TCanvas("can1", "can1",10,700,600,600);// 11,53,700,500
  can1->SetHighLightColor(2);
  gStyle->SetOptFit(0111);
  can1->SetFillColor(0);//10
  can1->SetBorderMode(0);
  can1->SetBorderSize(2);
  can1->SetFrameFillColor(0);
  can1->SetFrameBorderMode(0);
  can1->SetFrameBorderMode(0);
  can1->cd();
  TPad *pad1 = new TPad("pad1","pad1",0.,0.,1.,1.);
  gPad->SetTickx();
  gPad->SetTicky();
  pad1->SetTopMargin(0.0);//0.05
  pad1->SetRightMargin(0.0);//3e-2
  pad1->SetBottomMargin(0.0);//0.12
  pad1->SetLeftMargin(0.0);
  pad1->Draw();
  pad1->cd();
  TLegend *legend1 = new TLegend(.2,.65, .55,.85,NULL,"brNDC");//.45 or .4 for x1
  legend1->SetBorderSize(0);
  legend1->SetFillColor(0);
  legend1->SetTextFont(TextFont);
  legend1->SetTextSize(SizeLegend);

  gPad->SetRightMargin(0.01); gPad->SetLeftMargin(0.14);
  gPad->SetBottomMargin(0.14); gPad->SetTopMargin(0.02);
  gPad->SetTickx(); gPad->SetTicky();
  // pp, M18
  double points_K0s_C3[50]={1.44542, 1.33366, 1.25518, 1.21051, 1.20484, 1.18742, 1.18246, 1.17024, 1.16383, 1.1555, 1.15536, 1.15272, 1.14571, 1.14822, 1.14708, 1.14066, 1.14133, 1.13866, 1.13755, 1.13308, 1.1386, 1.13821, 1.13429, 1.13707, 1.13294, 1.13545, 1.13929, 1.13374, 1.13546, 1.13205, 1.12846, 1.1281, 1.12947, 1.13162, 1.13822, 1.13626, 1.13912, 1.14379, 1.15594, 1.19387, 1.29685, 1.21203, 1.14452, 1.14288, 1.14161, 1.1408, 1.13796, 1.13661, 1.13565, 1.13312};
  double points_K0s_C3_e[50]={0.0270571, 0.00940436, 0.0058043, 0.00430829, 0.00355541, 0.00306969, 0.00275566, 0.00253068, 0.00236966, 0.00224498, 0.00215682, 0.00208189, 0.00201555, 0.00196896, 0.00192381, 0.0018782, 0.00184374, 0.0018119, 0.00178103, 0.00175109, 0.00173313, 0.00171119, 0.00168873, 0.00167507, 0.00165525, 0.00164399, 0.00163488, 0.00161686, 0.00160668, 0.00159163, 0.00157479, 0.00155996, 0.00154251, 0.00152405, 0.00150469, 0.00147687, 0.00144939, 0.00142223, 0.0013988, 0.00139214, 0.00142684, 0.0013476, 0.00128368, 0.00126468, 0.0012497, 0.00123827, 0.001228, 0.00122253, 0.00121921, 0.00121782};
  double points_K0s_c3[50]={0.965148, 1.05077, 0.983133, 0.972848, 0.993922, 0.994064, 1.00618, 0.993434, 1.00322, 0.999747, 0.982221, 1.00029, 0.992184, 0.993566, 1.00007, 0.995263, 0.998559, 0.987037, 0.987919, 0.991035, 0.991488, 0.99592, 0.99677, 0.990709, 0.990352, 0.994706, 0.99606, 0.998525, 0.994121, 0.986511, 0.991009, 0.990309, 1.00161, 0.997478, 1.00117, 0.989375, 0.996592, 0.990832, 0.998989, 0.995124, 0.996301, 1.00189, 0.995304, 0.992511, 0.994084, 0.994777, 1.00074, 0.996959, 0.998713, 0.996205};
  double points_K0s_c3_e[50]={0.0630244, 0.0223583, 0.0140589, 0.0105446, 0.00871274, 0.00755392, 0.00678715, 0.00625387, 0.00586333, 0.00556614, 0.00535136, 0.00516553, 0.00501148, 0.00489185, 0.00478054, 0.00467542, 0.00458851, 0.00451377, 0.00443821, 0.00436787, 0.00431762, 0.00426282, 0.0042107, 0.00417461, 0.00412901, 0.00409783, 0.00407137, 0.0040317, 0.00400527, 0.00397212, 0.00393349, 0.00389671, 0.00385012, 0.00380258, 0.00374821, 0.0036816, 0.0036096, 0.00353852, 0.00346903, 0.00342075, 0.00342477, 0.00329675, 0.0031932, 0.00314748, 0.00311129, 0.00308337, 0.00305968, 0.00304743, 0.00303989, 0.00303859};
  TH1D *K0s_C3=new TH1D("K0s_C3","",50,0,0.5);
  TH1D *K0s_c3=new TH1D("K0s_c3","",50,0,0.5);
  for(int i=0; i<50; i++){
    K0s_C3->SetBinContent(i+1, points_K0s_C3[i]);
    K0s_C3->SetBinError(i+1, points_K0s_C3_e[i]);
    K0s_c3->SetBinContent(i+1, points_K0s_c3[i]);
    K0s_c3->SetBinError(i+1, points_K0s_c3_e[i]);
  }
  K0s_c3->SetMarkerStyle(20);
  K0s_c3->SetMarkerColor(4);
  K0s_C3->SetMarkerStyle(24);
  K0s_C3->SetMarkerColor(4);
  K0s_c3->SetMarkerSize(K0s_C3->GetMarkerSize() * 1.12);
  K0s_C3->SetMinimum(0.92);
  K0s_C3->GetXaxis()->SetTitle("#font[12]{q_{31}^{#pm#mp}} (GeV/#font[12]{c})");
  K0s_C3->GetYaxis()->SetTitle("#font[12]{C_{3}} or #font[12]{#bf{c}_{3}}"); 
  K0s_C3->GetXaxis()->SetTitleOffset(1.05); K0s_C3->GetYaxis()->SetTitleOffset(1.12);
  K0s_C3->GetXaxis()->SetTitleSize(SizeTitle); K0s_C3->GetYaxis()->SetTitleSize(SizeTitle);
  K0s_C3->GetXaxis()->SetLabelSize(SizeTitle); K0s_C3->GetYaxis()->SetLabelSize(SizeTitle);
  K0s_C3->GetXaxis()->SetNdivisions(404);
  K0s_C3->GetYaxis()->SetNdivisions(404);
  //K0s_C3->GetXaxis()->SetRangeUser(-0.001,0.5);

  K0s_C3->Draw();
  // Sys errors
  TH1D *Sys_K0s_C3=(TH1D*)K0s_C3->Clone();
  TH1D *Sys_K0s_c3=(TH1D*)K0s_c3->Clone();
  Sys_K0s_C3->SetMarkerSize(0); Sys_K0s_c3->SetMarkerSize(0);
  Sys_K0s_C3->SetFillColor(kBlue-10); Sys_K0s_c3->SetFillColor(kBlue-10);
  Sys_K0s_C3->SetFillStyle(1000); Sys_K0s_c3->SetFillStyle(1000);
  cout.precision(3);
  for(int i=0; i<Sys_K0s_C3->GetNbinsX(); i++) { 
    Sys_K0s_C3->SetBinError(i+1, 0.01 * Sys_K0s_C3->GetBinContent(i+1));
    Sys_K0s_c3->SetBinError(i+1, sqrt(pow(0.01 * Sys_K0s_c3->GetBinContent(i+1),2) + pow(0.1*(Sys_K0s_c3->GetBinContent(i+1)-1),2)));
    cout<<K0s_C3->GetXaxis()->GetBinLowEdge(i+1)<<" TO "<<K0s_C3->GetXaxis()->GetBinUpEdge(i+1)<<"; "<<K0s_C3->GetBinContent(i+1)<<" +- "<<K0s_C3->GetBinError(i+1)<<"  (DSYS="<<Sys_K0s_C3->GetBinError(i+1)<<"); "<<K0s_c3->GetBinContent(i+1)<<" +- "<<K0s_c3->GetBinError(i+1)<<"  (DSYS="<<Sys_K0s_c3->GetBinError(i+1)<<"); "<<endl;
    //cout<<K0s_C3->GetXaxis()->GetBinLowEdge(i+1)<<"  "<<K0s_C3->GetXaxis()->GetBinUpEdge(i+1)<<"    "<<K0s_c3->GetBinContent(i+1)<<"    "<<K0s_c3->GetBinError(i+1)<<"    "<<Sys_K0s_c3->GetBinError(i+1)<<endl;
  }

  Sys_K0s_C3->Draw("E2 same");
  Sys_K0s_c3->Draw("E2 same");
  K0s_C3->Draw("same");
  K0s_c3->Draw("same");

  legend1->AddEntry(K0s_C3,"#font[12]{C_{3}^{#pm#pm#mp}} projection","p");
  legend1->AddEntry(K0s_c3,"#font[12]{#bf{c}_{3}^{#pm#pm#mp}} projection","p");
  legend1->Draw("same");
  
  TLatex *Specif_qRange = new TLatex(0.25,0.6,"0.2 < #font[12]{q_{12}^{#pm#pm},q_{23}^{#pm#mp}} < 0.5 GeV/#font[12]{c}");
  Specif_qRange->SetNDC();
  Specif_qRange->SetTextFont(42);
  Specif_qRange->SetTextSize(SizeSpecif);
  Specif_qRange->Draw("same");
  TLatex *Specif_System = new TLatex(0.25,0.9,"pp #sqrt{#font[12]{s}}=7 TeV, #LT#font[12]{N}_{ch}#GT = 8.6 #pm 0.4");
  Specif_System->SetNDC();
  Specif_System->SetTextFont(42);
  Specif_System->SetTextSize(SizeSpecif);
  Specif_System->Draw("same");
  


  
  ////////////////////////////////////////////////////
  ////////////////////////////////////////////////////
  // Radii and lambda plot
  float SF_2panel=1.2;
  float RadiiC2ppPubPoints[2][8]={{0.88,1.09,1.23,1.28,1.34,1.37,1.42,1.48},{0.86,1.06,1.16,1.23,1.23,1.28,1.32,1.38}};
  float RadiiC2ppPubPoints_e[2][8]={{0.058,0.064,0.071,0.071,0.078,0.078,0.086,0.098},{0.12,0.12,0.13,0.13,0.13,0.13,0.13,0.13}};
  float MeanPubNch[8]={3.36, 7.92, 11.04, 14.4, 17.88, 21.48, 25.68, 33.12};// Adam's <dNch/deta> * 1.6 * 0.75.  Factor of 0.75 for low,high pt extrap

  int yExtent = 900;
  if(RadiusOnly) yExtent = 600;
  TCanvas *can3 = new TCanvas("can3", "can3",1000,0,600,yExtent);// 1000,0,600,900
  can3->SetHighLightColor(2);
  gStyle->SetOptFit(0111);
  can3->SetFillColor(0);//10
  can3->SetBorderMode(0);
  can3->SetBorderSize(2);
  can3->SetFrameFillColor(0);
  can3->SetFrameBorderMode(0);
  can3->SetFrameBorderMode(0);
  can3->cd();
  float PadLeftMargin=0.0, PadBottomMargin=0.;
  TPad *pad3 = new TPad("pad3","pad3",PadLeftMargin,PadBottomMargin,1.,1.);
  gPad->SetTickx();
  gPad->SetTicky();
  pad3->SetTopMargin(0.0);//0.05
  pad3->SetRightMargin(0.0);//3e-2
  pad3->SetBottomMargin(0.0);//0.12
  pad3->SetLeftMargin(0.0);
  if(!RadiusOnly) pad3->Divide(1,2,0,0);
  pad3->Draw();
  pad3->cd();
  TLegend *legend4 = new TLegend(.15,.65, .55,.95,NULL,"brNDC");//.45 or .4 for x1
  legend4->SetBorderSize(0);
  legend4->SetFillColor(0);
  legend4->SetTextFont(TextFont);
  legend4->SetTextSize(SizeLegend);
  //
  pad3->cd(1);
  gPad->SetLeftMargin(0.14);
  gPad->SetRightMargin(0.01);
  gPad->SetTopMargin(0.01);
  gPad->SetBottomMargin(0.001);// 0.16
  if(RadiusOnly){
    gPad->SetLeftMargin(0.16);
    gPad->SetBottomMargin(0.16);
  }

  gPad->SetTickx(); gPad->SetTicky();
  if(!NchOneThirdAxis)gPad->SetLogx();
  
  TH1D *RadiiPbPb=(TH1D*)Parameters_c3[0][FitType][KT3Bin][2]->Clone();
  TH1D *RadiipPb=(TH1D*)Parameters_c3[1][FitType][KT3Bin][2]->Clone();
  TH1D *Radiipp=(TH1D*)Parameters_c3[2][FitType][KT3Bin][2]->Clone();
  RadiiPbPb->GetXaxis()->SetLabelFont(TextFont); RadiiPbPb->GetYaxis()->SetLabelFont(TextFont); 
  RadiiPbPb->GetXaxis()->SetLabelSize(SizeLabel*SF_2panel); RadiiPbPb->GetYaxis()->SetLabelSize(SizeLabel*SF_2panel);
  RadiiPbPb->GetXaxis()->SetNdivisions(808);
  RadiiPbPb->GetXaxis()->SetTitleOffset(0.95);//1.3
  RadiiPbPb->GetYaxis()->SetTitleOffset(100);//1.1
  RadiiPbPb->GetXaxis()->SetTitleFont(TextFont); RadiiPbPb->GetXaxis()->SetTitleSize(0);// SizeTitle*SF_2panel
  RadiiPbPb->GetYaxis()->SetTitleFont(TextFont); RadiiPbPb->GetYaxis()->SetTitleSize(0);// SizeTitle*SF_2panel
  RadiiPbPb->SetMinimum(0.01); RadiiPbPb->SetMaximum(11.9);// 0 and 11.9
  //gStyle->SetErrorX(0);
  if(NchOneThirdAxis) RadiiPbPb->GetXaxis()->SetRangeUser(0,3000);// 0,3000
  else RadiiPbPb->GetXaxis()->SetRangeUser(3,3000);// 3,3000
  if(RadiusOnly){
    RadiiPbPb->GetXaxis()->SetTitleSize(SizeTitle);
    RadiiPbPb->GetXaxis()->SetTitleOffset(1.25);
    RadiiPbPb->GetYaxis()->SetTitleSize(SizeTitle);
    RadiiPbPb->GetYaxis()->SetTitleOffset(1.2);
    if(FitType==0) RadiiPbPb->GetYaxis()->SetTitle("#font[12]{R}^{#font[12]{G}}_{inv} or #font[12]{R}^{#font[12]{G}}_{inv,3} (fm)");
    else if(FitType==1) RadiiPbPb->GetYaxis()->SetTitle("#font[12]{R}^{#font[12]{E}_{w}}_{inv} or #font[12]{R}^{#font[12]{E}_{w}}_{inv,3} (fm)");
    else RadiiPbPb->GetYaxis()->SetTitle("#font[12]{R}^{#font[12]{Exp}_{inv} or #font[12]{R}^{#font[12]{Exp}_{inv,3} (fm)");
  }
  
  RadiiPbPb->Draw();
 
  //
  double xAxisC2_e[20]={0};
  double xAxis_e[20]={0};
  double yAxisPbPb[20]={0};
  double yAxisPbPb_eL[20]={0};
  double yAxisPbPb_eH[20]={0};
  double yAxispPb[20]={0};
  double yAxispPb_eL[20]={0};
  double yAxispPb_eH[20]={0};
  double yAxispp[20]={0};
  double yAxispp_eL[20]={0};
  double yAxispp_eH[20]={0};
  
  double SysPercent_PbPb_NFR[3][4]={{12,10,11,16}, {5,7,5,10}, {1,3,1,5}};// Gauss/EW/Exp, parameter#(Rinv2, Rinv3, lambda, lambda_3)
  // Narrow Fit Range for C2 fits
  double SysPercent_pPb_NFR[3][4]={{15,10,6,10}, {6,2,1,4}, {5,3,1,4}};// Gauss/EW/Exp, parameter#(Rinv2, Rinv3, lambda, lambda_3)   Old values with 30% fit range variation
  double SysPercent_pp_NFR[3][4]={{11,9,2,5}, {12,5,2,5}, {4,5,1,7}};// Gauss/EW/Exp, parameter#(Rinv2, Rinv3, lambda, lambda_3)   Old values with 30% fit range variation
  // Wide Fit Range for C2 fits
  double SysPercent_PbPb_WFR[3][4]={{25,10,12,16}, {8,7,3,10}, {10,3,6,5}};// Gauss/EW/Exp, parameter#(Rinv2, Rinv3, lambda, lambda_3) with pPb fit range
  double SysPercent_pPb_WFR[3][4]={{24,10,6,10}, {16,2,7,4}, {15,3,9,4}};// Gauss/EW/Exp, parameter#(Rinv2, Rinv3, lambda, lambda_3)   New values with 1.2 GeV/c fit range variation
  double SysPercent_pp_WFR[3][4]={{21,9,2,5}, {6,5,1,5}, {2,5,1,7}};// Gauss/EW/Exp, parameter#(Rinv2, Rinv3, lambda, lambda_3)   New values with 1.2 GeV/c fit range variation
  
  for(int cb=0; cb<20; cb++){// 3-particle
    int binPbPb = RadiiPbPb->GetXaxis()->FindBin(meanNchPbPb[cb]);
    int binpPb = RadiipPb->GetXaxis()->FindBin(meanNchpPb[cb]);
    int binpp = Radiipp->GetXaxis()->FindBin(meanNchpp[cb]);
    double RsysPbPb = 0.01*sqrt(pow(SysPercent_PbPb_NFR[FitType][1],2) + pow(1,2)) *  RadiiPbPb->GetBinContent(binPbPb);// fit Variation + MRC 
    double RsyspPb = 0.01*sqrt(pow(SysPercent_pPb_NFR[FitType][1],2) + pow(1,2)) *  RadiipPb->GetBinContent(binpPb);// fit Variation + MRC 
    double Rsyspp = 0.01*sqrt(pow(SysPercent_pp_NFR[FitType][1],2) + pow(1,2)) *  Radiipp->GetBinContent(binpp);// fit Variation + MRC 
    //
    if(cb==19 && FitType==2) Rsyspp =  0.01*sqrt(pow(16,2) + pow(1,2)) *  Radiipp->GetBinContent(binpp);// larger fit var in this bin
    
    if(RadiiPbPb->GetBinContent(binPbPb)==0) {yAxisPbPb[cb]=100; yAxisPbPb_eL[cb]=100; yAxisPbPb_eH[cb]=100;}// errors were 100
    else {yAxisPbPb[cb]=RadiiPbPb->GetBinContent(binPbPb); yAxisPbPb_eL[cb]=RsysPbPb; yAxisPbPb_eH[cb]=RsysPbPb;}
    //
    if(RadiipPb->GetBinContent(binpPb)==0) {yAxispPb[cb]=100; yAxispPb_eL[cb]=100; yAxispPb_eH[cb]=100;}
    else {yAxispPb[cb]=RadiipPb->GetBinContent(binpPb); yAxispPb_eL[cb]=RsyspPb; yAxispPb_eH[cb]=RsyspPb;}
    //
    if(Radiipp->GetBinContent(binpp)==0) {yAxispp[cb]=100; yAxispp_eL[cb]=100; yAxispp_eH[cb]=100;}
    else {yAxispp[cb]=Radiipp->GetBinContent(binpp); yAxispp_eL[cb]=Rsyspp; yAxispp_eH[cb]=Rsyspp;}
    //
    
    if(NchOneThirdAxis) {
      if(cb<13) xAxis_e[cb]=fabs(meanNchPbPb[cb] - pow(0.95,1/3.)*meanNchPbPb[cb]);
      else xAxis_e[cb]=fabs(meanNchpPb[cb] - pow(0.95,1/3.)*meanNchpPb[cb]);
    }else {
      if(cb<13) xAxis_e[cb]=fabs(meanNchPbPb[cb] - (0.95)*meanNchPbPb[cb]);
      else xAxis_e[cb]=fabs(meanNchpPb[cb] - (0.95)*meanNchpPb[cb]);
    }
  }
  
 
  TGraphErrors *grRadiiSys_PbPb=new TGraphErrors(20,meanNchPbPb,yAxisPbPb,xAxis_e,yAxisPbPb_eL);
  TGraphAsymmErrors *grRadiiSys_pPb=new TGraphAsymmErrors(20,meanNchpPb,yAxispPb, xAxis_e,xAxis_e, yAxispPb_eL,yAxispPb_eH);
  TGraphAsymmErrors *grRadiiSys_pp=new TGraphAsymmErrors(20,meanNchpp,yAxispp, xAxis_e,xAxis_e, yAxispp_eL,yAxispp_eH);
  grRadiiSys_pp->SetMarkerSize(0); grRadiiSys_pp->SetFillStyle(1000); grRadiiSys_pp->SetFillColor(kBlue-10);
  grRadiiSys_pPb->SetMarkerSize(0); grRadiiSys_pPb->SetFillStyle(1000); grRadiiSys_pPb->SetFillColor(kRed-10);
  grRadiiSys_PbPb->SetMarkerSize(0); grRadiiSys_PbPb->SetFillStyle(1000); grRadiiSys_PbPb->SetFillColor(kGray);
  grRadiiSys_pp->SetMarkerColor(kBlue-10); grRadiiSys_pp->SetMarkerColor(kRed-10); grRadiiSys_pp->SetMarkerColor(kGray);
  // C2 
  TH1D *RadiiC2PbPb=(TH1D*)Parameters_C2[0][FitType][KT3Bin][2]->Clone();
  TH1D *RadiiC2pPb=(TH1D*)Parameters_C2[1][FitType][KT3Bin][2]->Clone();
  TH1D *RadiiC2pp=(TH1D*)Parameters_C2[2][FitType][KT3Bin][2]->Clone();
  RadiiC2pp_Published->SetMarkerStyle(30);
  //if(FitType==0) RadiiC2pp->SetMarkerStyle(30);// for legend marker

  for(int mbin=0; mbin<8; mbin++){
    int bin = RadiiC2pp_Published->GetXaxis()->FindBin(MeanPubNch[mbin]);
    RadiiC2pp_Published->SetBinContent(bin, RadiiC2ppPubPoints[KT3Bin][mbin]); 
    RadiiC2pp_Published->SetBinError(bin, RadiiC2ppPubPoints_e[KT3Bin][mbin]);
  }  

  for(int cb=0; cb<20; cb++){// 2-particle
    int binPbPb = RadiiC2PbPb->GetXaxis()->FindBin(meanNchPbPb[cb]);
    int binpPb = RadiiC2pPb->GetXaxis()->FindBin(meanNchpPb[cb]);
    int binpp = RadiiC2pp->GetXaxis()->FindBin(meanNchpp[cb]);
    double RsysPbPb_L = 0.01*sqrt(pow(SysPercent_PbPb_WFR[FitType][0],2) + pow(1,2)) *  RadiiC2PbPb->GetBinContent(binPbPb);// fit Variation + MRC
    double RsysPbPb_H = 0.01*sqrt(pow(SysPercent_PbPb_NFR[FitType][0],2) + pow(1,2)) *  RadiiC2PbPb->GetBinContent(binPbPb);// fit Variation + MRC
    double RsyspPb_L = 0.01*sqrt(pow(SysPercent_pPb_WFR[FitType][0],2) + pow(1,2)) *  RadiiC2pPb->GetBinContent(binpPb);// fit Variation + MRC
    double RsyspPb_H = 0.01*sqrt(pow(SysPercent_pPb_NFR[FitType][0],2) + pow(1,2)) *  RadiiC2pPb->GetBinContent(binpPb);// fit Variation + MRC
    double Rsyspp_L = 0.01*sqrt(pow(SysPercent_pp_WFR[FitType][0],2) + pow(1,2)) *  RadiiC2pp->GetBinContent(binpp);// fit Variation + MRC
    double Rsyspp_H = 0.01*sqrt(pow(SysPercent_pp_NFR[FitType][0],2) + pow(1,2)) *  RadiiC2pp->GetBinContent(binpp);// fit Variation + MRC
    //
    if(cb==15) RsysPbPb_L = 0.01*sqrt(pow(1.5*SysPercent_PbPb_WFR[FitType][0],2) + pow(1,2)) *  RadiiC2PbPb->GetBinContent(binPbPb);// larger error
    //
    
    if(RadiiC2PbPb->GetBinContent(binPbPb)==0) {yAxisPbPb[cb]=100; yAxisPbPb_eL[cb]=1000; yAxisPbPb_eH[cb]=1000;}// errors were 1000
    else {
      yAxisPbPb[cb]=RadiiC2PbPb->GetBinContent(binPbPb);
      if(cb>=13) yAxisPbPb_eL[cb]=RsysPbPb_L;
      else yAxisPbPb_eL[cb]=RsysPbPb_H;
      yAxisPbPb_eH[cb]=RsysPbPb_H;
    }
    if(RadiiC2pPb->GetBinContent(binpPb)==0) {yAxispPb[cb]=100; yAxispPb_eL[cb]=1000; yAxispPb_eH[cb]=1000;}
    else {yAxispPb[cb]=RadiiC2pPb->GetBinContent(binpPb); yAxispPb_eL[cb]=RsyspPb_L; yAxispPb_eH[cb]=RsyspPb_H;}
    if(RadiiC2pp->GetBinContent(binpp)==0) {yAxispp[cb]=100; yAxispp_eL[cb]=1000; yAxispp_eH[cb]=1000;}
    else {yAxispp[cb]=RadiiC2pp->GetBinContent(binpp); yAxispp_eL[cb]=Rsyspp_L; yAxispp_eH[cb]=Rsyspp_H;}
    //
  }
 
  TGraphAsymmErrors *grRadiiC2Sys_PbPb=new TGraphAsymmErrors(20,meanNchPbPb,yAxisPbPb, xAxisC2_e,xAxisC2_e, yAxisPbPb_eL,yAxisPbPb_eH);
  TGraphAsymmErrors *grRadiiC2Sys_pPb=new TGraphAsymmErrors(20,meanNchpPb,yAxispPb, xAxisC2_e,xAxisC2_e, yAxispPb_eL,yAxispPb_eH);
  TGraphAsymmErrors *grRadiiC2Sys_pp=new TGraphAsymmErrors(20,meanNchpp,yAxispp, xAxisC2_e,xAxisC2_e, yAxispp_eL,yAxispp_eH);
  grRadiiC2Sys_pp->SetMarkerSize(0); 
  grRadiiC2Sys_pPb->SetMarkerSize(0);
  grRadiiC2Sys_PbPb->SetMarkerSize(0);
  grRadiiC2Sys_pp->SetLineColor(4); grRadiiC2Sys_pPb->SetLineColor(2); grRadiiC2Sys_PbPb->SetLineColor(1);
  grRadiiC2Sys_pp->SetLineWidth(2.*grRadiiC2Sys_pp->GetLineWidth());
  grRadiiC2Sys_pPb->SetLineWidth(2.*grRadiiC2Sys_pPb->GetLineWidth());
  grRadiiC2Sys_PbPb->SetLineWidth(1.*grRadiiC2Sys_PbPb->GetLineWidth()); grRadiiC2Sys_PbPb->SetLineStyle(2);
  //
  grRadiiC2Sys_pPb->Draw("|| p");
  grRadiiC2Sys_pp->Draw("|| p");
 
  grRadiiSys_pp->Draw("E2 p");
  grRadiiSys_pPb->Draw("E2 p");
  grRadiiSys_PbPb->Draw("E2 p");
  RadiiPbPb->Draw("same");
  RadiipPb->Draw("same");
  Radiipp->Draw("same");
  grRadiiC2Sys_PbPb->Draw("E");// E2 or "|| p" to visualize pol2 fit below
  //if(FitType==0) RadiiC2pp_Published->Draw("same");
  //
  
  RadiiC2PbPb->Draw("same");
  RadiiC2pPb->Draw("same");
  RadiiC2pp->Draw("same");
  
 
  legend4->AddEntry(Radiipp,"pp #sqrt{s}=7 TeV","p");
  legend4->AddEntry(RadiipPb,"p-Pb #sqrt{#font[12]{s}_{NN}}=5.02 TeV","p");
  legend4->AddEntry(RadiiPbPb,"Pb-Pb #sqrt{#font[12]{s}_{NN}}=2.76 TeV","p");

  TF1 *ppLine = new TF1("ppLine","pol1",0,13);
  ppLine->SetLineColor(4);
  TF1 *pPbLine = new TF1("pPbLine","pol1",0,13);
  TF1 *PbPbLine = new TF1("PbPbLine","pol1",0,13);
  PbPbLine->SetLineColor(1);
  if(NchOneThirdAxis){
    Radiipp->Fit(ppLine,"IMEN","",1,4.);
    ppLine->Draw("same");
    RadiipPb->Fit(pPbLine,"IMEN","",2,4.5);
    pPbLine->Draw("same");
    RadiiC2PbPb->Fit(PbPbLine,"IMEN","",4,13);
    PbPbLine->Draw("same");
  }
  
  TLatex *Specif_Kt3;
  TLatex *Specif_kt;
  if(KT3Bin==0) {
    Specif_Kt3 = new TLatex(0.17, 0.57,"0.16<#font[12]{K}_{T,3}<0.3 GeV/#font[12]{c}"); 
    Specif_kt = new TLatex(0.17, 0.47,"0.2<#font[12]{k}_{T}<0.3 GeV/#font[12]{c}");
    // KT3:  #LT#font[12]{k}_{T}#GT=0.24 GeV/#font[12]{c}
    // kT:  #LT#font[12]{k}_{T}#GT=0.25 GeV/#font[12]{c}
  }
  if(KT3Bin==1) {
    Specif_Kt3 = new TLatex(0.17, 0.57,"0.3<#font[12]{K}_{T,3}<1.0 GeV/#font[12]{c}"); 
    Specif_kt = new TLatex(0.17, 0.47,"0.3<#font[12]{k}_{T}<1.0 GeV/#font[12]{c}");
    // KT3:  #LT#font[12]{k}_{T}#GT=0.39 GeV/#font[12]{c}
    // kT:  #LT#font[12]{k}_{T}#GT=0.43 GeV/#font[12]{c}
  }
  //if(KT3Bin==0) {Specif_Kt3 = new TLatex(0.57, 0.83,"0.16<K_{T,3}<0.25 GeV/#font[12]{c}"); Specif_kt = new TLatex(0.57, 0.76,"0.2<k_{T}<0.3 GeV/#font[12]{c}");}
  //if(KT3Bin==1) {Specif_Kt3 = new TLatex(0.57, 0.83,"0.25<K_{T,3}<0.35 GeV/#font[12]{c}"); Specif_kt = new TLatex(0.57, 0.76,"0.3<k_{T}<0.4 GeV/#font[12]{c}");}
  //if(KT3Bin==2) {Specif_Kt3 = new TLatex(0.57, 0.83,"0.35<K_{T,3}<1.0 GeV/#font[12]{c}"); Specif_kt = new TLatex(0.57, 0.76,"0.4<k_{T}<0.5 GeV/#font[12]{c}");}
  Specif_Kt3->SetTextFont(TextFont); Specif_kt->SetTextFont(TextFont);
  Specif_Kt3->SetTextSize(SizeSpecif*SF_2panel); Specif_kt->SetTextSize(SizeSpecif*SF_2panel);
  Specif_Kt3->SetNDC(); Specif_kt->SetNDC();
  if(!RadiusOnly){
    Specif_Kt3->Draw("same");
    Specif_kt->Draw("same");
  }
  legend4->SetTextFont(TextFont);
  legend4->SetTextSize(SizeLegend*SF_2panel);
  if(RadiusOnly) legend4->SetTextSize(SizeLegend*SF_2panel*0.8);
  legend4->Draw("same");
  
  TH1D *MarkerPbPb_3=(TH1D*)RadiiPbPb->Clone();
  TH1D *MarkerpPb_3=(TH1D*)RadiipPb->Clone();
  TH1D *Markerpp_3=(TH1D*)Radiipp->Clone();
  TH1D *MarkerPbPb_2=(TH1D*)RadiiC2PbPb->Clone();
  TH1D *MarkerpPb_2=(TH1D*)RadiiC2pPb->Clone();
  TH1D *Markerpp_2=(TH1D*)RadiiC2pp->Clone();
  for(int i=1; i<=MarkerPbPb_3->GetNbinsX(); i++){
    MarkerPbPb_3->SetBinContent(i,1000); MarkerpPb_3->SetBinContent(i,1000); Markerpp_3->SetBinContent(i,1000);
    MarkerPbPb_2->SetBinContent(i,1000); MarkerpPb_2->SetBinContent(i,1000); Markerpp_2->SetBinContent(i,1000);
    MarkerPbPb_3->SetBinError(i,0.001); MarkerpPb_3->SetBinError(i,0.001); Markerpp_3->SetBinError(i,0.001);
    MarkerPbPb_2->SetBinError(i,0.001); MarkerpPb_2->SetBinError(i,0.001); Markerpp_2->SetBinError(i,0.001);
  }
  if(!NchOneThirdAxis){
    MarkerPbPb_3->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(450), 1.25);// 1.25, 1.45 for RadiusOnly
    MarkerpPb_3->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(600), 1.25);// 1.25, 1.45 for RadiusOnly
    Markerpp_3->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(800), 1.25);// 1.25, 1.45 for RadiusOnly
    MarkerPbPb_2->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(450), 3.1);// 3.1
    MarkerpPb_2->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(600), 3.1);// 3.1
    Markerpp_2->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(800), 3.1);// 3.1
  }else{
    MarkerPbPb_3->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(10), 1.25);// 1.25
    MarkerpPb_3->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(10.5), 1.25);// 1.25
    Markerpp_3->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(11), 1.25);// 1.25
    MarkerPbPb_2->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(10), 3.1);// 3.1
    MarkerpPb_2->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(10.5), 3.1);// 3.1
    Markerpp_2->SetBinContent(MarkerPbPb_3->GetXaxis()->FindBin(11), 3.1);// 3.1
  }

  MarkerPbPb_3->Draw("same"); MarkerpPb_3->Draw("same"); Markerpp_3->Draw("same");
  MarkerPbPb_2->Draw("same"); MarkerpPb_2->Draw("same"); Markerpp_2->Draw("same");

  TLatex *TwoPionText; 
  if(!RadiusOnly) TwoPionText = new TLatex(0.74,0.3,"Two-Pions");// 0.74,0.3
  else TwoPionText = new TLatex(0.67,0.31,"Two-Pions");// 
  TLatex *ThreePionText; 
  if(!RadiusOnly) ThreePionText = new TLatex(0.74,0.15,"Three-Pions");// 0.74,0.15
  else ThreePionText = new TLatex(0.65,0.2,"Three-Pions");// 
  TwoPionText->SetNDC(); ThreePionText->SetNDC(); 
  TwoPionText->SetTextFont(TextFont); ThreePionText->SetTextFont(TextFont);
  TwoPionText->SetTextSize(SizeSpecif*SF_2panel); ThreePionText->SetTextSize(SizeSpecif*SF_2panel);
  TwoPionText->Draw("same");
  ThreePionText->Draw("same");
  
  TLatex *Specif_kappas = new TLatex(0.42,0.05,"#kappa_{3}=0.1, #kappa_{4}=0.5");// 0.42,0.2
  //TLatex *Specif_kappas = new TLatex(0.42,0.05,"#kappa_{3}(N_{ch}), #kappa_{4}=0.5");// 0.42,0.2
  Specif_kappas->SetNDC();
  Specif_kappas->SetTextFont(TextFont);
  Specif_kappas->SetTextSize(SizeSpecif*SF_2panel);
  if(FitType==1 && !RadiusOnly) Specif_kappas->Draw("same");

  if(RadiusOnly) return;
  
  ///////////////////////////////////////////////////////////////////
  pad3->cd(2);
  gPad->SetLeftMargin(0.14);
  gPad->SetRightMargin(0.01);
  gPad->SetTopMargin(0.0);// 0.01
  gPad->SetBottomMargin(0.16);
  gPad->SetTickx(); gPad->SetTicky();
  if(!NchOneThirdAxis) gPad->SetLogx();
  //gPad->SetGridx(); gPad->SetGridy();
  TH1D *LambdaPbPb=(TH1D*)Parameters_c3[0][FitType][KT3Bin][5]->Clone();
  TH1D *LambdapPb=(TH1D*)Parameters_c3[1][FitType][KT3Bin][5]->Clone();
  TH1D *Lambdapp=(TH1D*)Parameters_c3[2][FitType][KT3Bin][5]->Clone();
  
  LambdaPbPb->GetXaxis()->SetLabelFont(TextFont); LambdaPbPb->GetYaxis()->SetLabelFont(TextFont); 
  LambdaPbPb->GetXaxis()->SetLabelSize(SizeLabel*SF_2panel); LambdaPbPb->GetYaxis()->SetLabelSize(SizeLabel*SF_2panel);
  LambdaPbPb->GetXaxis()->SetNdivisions(808);
  LambdaPbPb->GetYaxis()->SetNdivisions(604);
  LambdaPbPb->GetXaxis()->SetTitleFont(TextFont); LambdaPbPb->GetXaxis()->SetTitleSize(SizeTitle*SF_2panel);
  LambdaPbPb->GetYaxis()->SetTitleFont(TextFont); LambdaPbPb->GetYaxis()->SetTitleSize(SizeTitle*SF_2panel);
  LambdaPbPb->SetMaximum(2.8);// 2.8
  if(FitType==2) LambdaPbPb->SetMaximum(5.8);
  LambdaPbPb->GetXaxis()->SetTitleOffset(0.95);
  LambdaPbPb->GetYaxis()->SetTitleOffset(100);//1.1
  if(NchOneThirdAxis) LambdaPbPb->GetXaxis()->SetRangeUser(0,3000);// 0,3000
  else LambdaPbPb->GetXaxis()->SetRangeUser(3,3000);// 3,3000
  LambdaPbPb->Draw();
  
  TF1 *ChaoticLimit_C2 = new TF1("ChaoticLimit_C2","1.0",0,5000);
  TF1 *ChaoticLimit_c3 = new TF1("ChaoticLimit_c3","2.0",0,5000);
  ChaoticLimit_C2->SetLineColor(1); ChaoticLimit_c3->SetLineColor(1);
  ChaoticLimit_C2->SetLineStyle(7); ChaoticLimit_c3->SetLineStyle(6);
  ChaoticLimit_C2->Draw("same");
  ChaoticLimit_c3->Draw("same");

  for(int cb=0; cb<20; cb++){// 3-particle
    int binPbPb = LambdaPbPb->GetXaxis()->FindBin(meanNchPbPb[cb]);
    int binpPb = LambdapPb->GetXaxis()->FindBin(meanNchpPb[cb]);
    int binpp = Lambdapp->GetXaxis()->FindBin(meanNchpp[cb]);
    double f_syst_PbPb = 0, f_syst_pPb=0, f_syst_pp=0;
    if(cb<=12) f_syst_PbPb = 100 * (c3_mixedChargeSysFit[0][KT3Bin][cb]->Eval(0.025)-1.0) /  (c3_fit[0][1][KT3Bin][cb]->Eval(0.025)-1.0);// residue / EW fit at Q3=0.025
    if(cb>=12 && cb<19) f_syst_pPb = 100 * (c3_mixedChargeSysFit[1][KT3Bin][cb]->Eval(0.075)-1.0) /  (c3_fit[1][1][KT3Bin][cb]->Eval(0.075)-1.0);// residue / EW fit at Q3=0.075
    if(cb>=14) f_syst_pp = 100 * (c3_mixedChargeSysFit[2][KT3Bin][cb]->Eval(0.075)-1.0) /  (c3_fit[2][1][KT3Bin][cb]->Eval(0.075)-1.0);// residue / EW fit at Q3=0.075
    double LambdasysPbPb = 0.01*sqrt(pow(SysPercent_PbPb_NFR[FitType][3],2) + pow(1,2) + pow(5,2) + pow(10,2) + pow(f_syst_PbPb,2)) *  LambdaPbPb->GetBinContent(binPbPb);// fit Variation + MRC + TTC + undilution + f1,f2,f3 uncertainties
    double LambdasyspPb = 0.01*sqrt(pow(SysPercent_pPb_WFR[FitType][3],2) + pow(1,2) + pow(10,2) + pow(f_syst_pPb,2)) *  LambdapPb->GetBinContent(binpPb);// fit Variation + MRC + undilution + f1,f2,f3 uncertainties
    double Lambdasyspp = 0.01*sqrt(pow(SysPercent_pp_WFR[FitType][3],2) + pow(1,2) + pow(10,2) + pow(f_syst_pp,2)) *  Lambdapp->GetBinContent(binpp);// fit Variation + MRC + undilution + f1,f2,f3 uncertainties
    if(cb==19 && FitType==2) Lambdasyspp = 0.01*sqrt(pow(25,2) + pow(1,2) + pow(10,2) + pow(f_syst_pp,2)) *  Lambdapp->GetBinContent(binpp);// larger fit var in this bin
    if(LambdaPbPb->GetBinContent(binPbPb)==0) {yAxisPbPb[cb]=100; yAxisPbPb_eL[cb]=100; yAxisPbPb_eH[cb]=100;}// errors were 100
    else {yAxisPbPb[cb]=LambdaPbPb->GetBinContent(binPbPb); yAxisPbPb_eL[cb]=LambdasysPbPb; yAxisPbPb_eH[cb]=LambdasysPbPb;}
    //
    if(LambdapPb->GetBinContent(binpPb)==0) {yAxispPb[cb]=100; yAxispPb_eL[cb]=100; yAxispPb_eH[cb]=100;}
    else {yAxispPb[cb]=LambdapPb->GetBinContent(binpPb); yAxispPb_eL[cb]=LambdasyspPb; yAxispPb_eH[cb]=LambdasyspPb;}
    //
    if(Lambdapp->GetBinContent(binpp)==0) {yAxispp[cb]=100; yAxispp_eL[cb]=100; yAxispp_eH[cb]=100;}
    else {yAxispp[cb]=Lambdapp->GetBinContent(binpp); yAxispp_eL[cb]=Lambdasyspp; yAxispp_eH[cb]=Lambdasyspp;}
   

    if(NchOneThirdAxis) {
      if(cb<13) xAxis_e[cb]=fabs(meanNchPbPb[cb] - pow(0.95,1/3.)*meanNchPbPb[cb]);
      else xAxis_e[cb]=fabs(meanNchpPb[cb] - pow(0.95,1/3.)*meanNchpPb[cb]);
    }else {
      if(cb<13) xAxis_e[cb]=fabs(meanNchPbPb[cb] - (0.95)*meanNchPbPb[cb]);
      else xAxis_e[cb]=fabs(meanNchpPb[cb] - (0.95)*meanNchpPb[cb]);
    }
  }
  
  TGraphErrors *grLambdaSys_PbPb=new TGraphErrors(20,meanNchPbPb,yAxisPbPb,xAxis_e,yAxisPbPb_eL);
  TGraphAsymmErrors *grLambdaSys_pPb=new TGraphAsymmErrors(20,meanNchpPb,yAxispPb, xAxis_e,xAxis_e, yAxispPb_eL,yAxispPb_eH);
  TGraphAsymmErrors *grLambdaSys_pp=new TGraphAsymmErrors(20,meanNchpp,yAxispp, xAxis_e,xAxis_e, yAxispp_eL,yAxispp_eH);
  grLambdaSys_pp->SetMarkerSize(0); grLambdaSys_pp->SetFillStyle(1000); grLambdaSys_pp->SetFillColor(kBlue-10);
  grLambdaSys_pPb->SetMarkerSize(0); grLambdaSys_pPb->SetFillStyle(1000); grLambdaSys_pPb->SetFillColor(kRed-10);
  grLambdaSys_PbPb->SetMarkerSize(0); grLambdaSys_PbPb->SetFillStyle(1000); grLambdaSys_PbPb->SetFillColor(kGray);
  grLambdaSys_pp->SetMarkerColor(kBlue-10); grLambdaSys_pPb->SetMarkerColor(kRed-10); grLambdaSys_PbPb->SetMarkerColor(kGray);
  // C2 sys
  TH1D *LambdaC2PbPb=(TH1D*)Parameters_C2[0][FitType][KT3Bin][5]->Clone();
  TH1D *LambdaC2pPb=(TH1D*)Parameters_C2[1][FitType][KT3Bin][5]->Clone();
  TH1D *LambdaC2pp=(TH1D*)Parameters_C2[2][FitType][KT3Bin][5]->Clone();
  for(int cb=0; cb<20; cb++){// 2-particle
    int binPbPb = LambdaC2PbPb->GetXaxis()->FindBin(meanNchPbPb[cb]);
    int binpPb = LambdaC2pPb->GetXaxis()->FindBin(meanNchpPb[cb]);
    int binpp = LambdaC2pp->GetXaxis()->FindBin(meanNchpp[cb]);
    double LambdasysPbPb_H = 0.01*sqrt(pow(SysPercent_PbPb_NFR[FitType][2],2) + pow(1,2) + pow(5,2) + pow(7,2)) *  LambdaC2PbPb->GetBinContent(binPbPb);// fit Variation + MRC + TTC + undilution
    double LambdasysPbPb_L = 0.01*sqrt(pow(SysPercent_PbPb_WFR[FitType][2],2) + pow(1,2) + pow(5,2) + pow(7,2)) *  LambdaC2PbPb->GetBinContent(binPbPb);// fit Variation + MRC + TTC + undilution
    double LambdasyspPb_H = 0.01*sqrt(pow(SysPercent_pPb_NFR[FitType][2],2) + pow(1,2) + pow(7,2)) *  LambdaC2pPb->GetBinContent(binpPb);// fit Variation + MRC + undilution
    double LambdasyspPb_L = 0.01*sqrt(pow(SysPercent_pPb_WFR[FitType][2],2) + pow(1,2) + pow(7,2)) *  LambdaC2pPb->GetBinContent(binpPb);// fit Variation + MRC + undilution
    double Lambdasyspp_H = 0.01*sqrt(pow(SysPercent_pp_NFR[FitType][2],2) + pow(1,2) + pow(7,2)) *  LambdaC2pp->GetBinContent(binpp);// fit Variation + MRC + undilution
    double Lambdasyspp_L = 0.01*sqrt(pow(SysPercent_pp_WFR[FitType][2],2) + pow(1,2) + pow(7,2)) *  LambdaC2pp->GetBinContent(binpp);// fit Variation + MRC + undilution
    //
    if(LambdaC2PbPb->GetBinContent(binPbPb)==0) {yAxisPbPb[cb]=100; yAxisPbPb_eL[cb]=100; yAxisPbPb_eH[cb]=100;}// errors were 100
    else {
      yAxisPbPb[cb]=LambdaC2PbPb->GetBinContent(binPbPb); 
      if(cb>=13) yAxisPbPb_eL[cb]=LambdasysPbPb_L; 
      else yAxisPbPb_eL[cb]=LambdasysPbPb_H;
      yAxisPbPb_eH[cb]=LambdasysPbPb_H;
    }
    //    
    if(LambdaC2pPb->GetBinContent(binpPb)==0) {yAxispPb[cb]=100; yAxispPb_eL[cb]=100; yAxispPb_eH[cb]=100;}
    else {yAxispPb[cb]=LambdaC2pPb->GetBinContent(binpPb); yAxispPb_eL[cb]=LambdasyspPb_L; yAxispPb_eH[cb]=LambdasyspPb_H;}
    //
    if(LambdaC2pp->GetBinContent(binpp)==0) {yAxispp[cb]=100; yAxispp_eL[cb]=100; yAxispp_eH[cb]=100;}
    else {yAxispp[cb]=LambdaC2pp->GetBinContent(binpp); yAxispp_eL[cb]=Lambdasyspp_L; yAxispp_eH[cb]=Lambdasyspp_H;}
    //xAxis_e[cb]=10000;
  }
  TGraphAsymmErrors *grLambdaC2Sys_PbPb=new TGraphAsymmErrors(20,meanNchPbPb,yAxisPbPb,xAxisC2_e,xAxisC2_e, yAxisPbPb_eL,yAxisPbPb_eH);
  TGraphAsymmErrors *grLambdaC2Sys_pPb=new TGraphAsymmErrors(20,meanNchpPb,yAxispPb, xAxisC2_e,xAxisC2_e, yAxispPb_eL,yAxispPb_eH);
  TGraphAsymmErrors *grLambdaC2Sys_pp=new TGraphAsymmErrors(20,meanNchpp,yAxispp, xAxisC2_e,xAxisC2_e, yAxispp_eL,yAxispp_eH);
  grLambdaC2Sys_pp->SetMarkerSize(0); grLambdaC2Sys_pp->SetFillStyle(3001); grLambdaC2Sys_pp->SetFillColor(0);
  grLambdaC2Sys_pPb->SetMarkerSize(0); grLambdaC2Sys_pPb->SetFillStyle(3001); grLambdaC2Sys_pPb->SetFillColor(0);
  grLambdaC2Sys_PbPb->SetMarkerSize(0); grLambdaC2Sys_PbPb->SetFillStyle(3001); grLambdaC2Sys_PbPb->SetFillColor(0);
  grLambdaC2Sys_pp->SetLineColor(4); grLambdaC2Sys_pPb->SetLineColor(2); grLambdaC2Sys_PbPb->SetLineColor(1);
  grLambdaC2Sys_pp->SetLineWidth(2.*grLambdaC2Sys_pp->GetLineWidth());
  grLambdaC2Sys_pPb->SetLineWidth(2.*grLambdaC2Sys_pPb->GetLineWidth());
  grLambdaC2Sys_PbPb->SetLineWidth(2.*grLambdaC2Sys_PbPb->GetLineWidth());
  //
  
  
  grLambdaSys_pp->Draw("E2 p");
  grLambdaSys_pPb->Draw("E2 p");
  grLambdaSys_PbPb->Draw("E2 p");
  //
  LambdaPbPb->Draw("same");
  LambdapPb->Draw("same");
  Lambdapp->Draw("same");
  //
  LambdaC2PbPb->Draw("same");
  LambdaC2pPb->Draw("same");
  LambdaC2pp->Draw("same");
  
  grLambdaC2Sys_pp->Draw("|| p");
  grLambdaC2Sys_pPb->Draw("|| p");
  grLambdaC2Sys_PbPb->Draw("|| p");

  // print radii and lambda
  cout.precision(3);
  cout<<"Radii and Lambda data"<<endl;
  cout<<"p--p:"<<endl;
  // new way for HEP
  for(int cb=19; cb>=0; cb--){
    int binpp = RadiiC2pp->GetXaxis()->FindBin(meanNchpp[cb]);
    if(Radiipp->GetBinContent(binpp)==0) continue;
    cout<<meanNchpp[cb]-(0.05)*meanNchpp[cb]<<" TO "<<meanNchpp[cb]+(0.05)*meanNchpp[cb]<<"; "<<RadiiC2pp->GetBinContent(binpp)<<" +- "<<RadiiC2pp->GetBinError(binpp)<<" (DSYS=+"<<grRadiiC2Sys_pp->GetErrorYhigh(cb)<<", -"<<grRadiiC2Sys_pp->GetErrorYlow(cb)<<"); ";
    cout<<LambdaC2pp->GetBinContent(binpp)<<" +- "<<LambdaC2pp->GetBinError(binpp)<<" (DSYS=+"<<grLambdaC2Sys_pp->GetErrorYhigh(cb)<<", -"<<grLambdaC2Sys_pp->GetErrorYlow(cb)<<"); ";
    cout<<Radiipp->GetBinContent(binpp)<<" +- "<<Radiipp->GetBinError(binpp)<<" (DSYS="<<grRadiiSys_pp->GetErrorY(cb)<<"); ";
    cout<<Lambdapp->GetBinContent(binpp)<<" +- "<<Lambdapp->GetBinError(binpp)<<" (DSYS="<<grLambdaSys_pp->GetErrorY(cb)<<");"<<endl;
    // Edgeworth lambdas
    //cout<<meanNchpp[cb]-(0.05)*meanNchpp[cb]<<"  "<<meanNchpp[cb]+(0.05)*meanNchpp[cb]<<"     "<<LambdaC2pp->GetBinContent(binpp)<<"     "<<LambdaC2pp->GetBinError(binpp)<<"     "<<grLambdaC2Sys_pp->GetErrorYhigh(cb)<<"     "<<grLambdaC2Sys_pp->GetErrorYlow(cb)<<"           "<<Lambdapp->GetBinContent(binpp)<<"     "<<Lambdapp->GetBinError(binpp)<<"     "<<grLambdaSys_pp->GetErrorY(cb)<<endl;
  }
  cout<<endl;
  
  cout<<"p--Pb:"<<endl;
  for(int cb=19; cb>=0; cb--){
    int binpPb = RadiiC2pPb->GetXaxis()->FindBin(meanNchpPb[cb]);
    if(RadiipPb->GetBinContent(binpPb)==0) continue;
    cout<<meanNchpPb[cb]-(0.05)*meanNchpPb[cb]<<" TO "<<meanNchpPb[cb]+(0.05)*meanNchpPb[cb]<<"; "<<RadiiC2pPb->GetBinContent(binpPb)<<" +- "<<RadiiC2pPb->GetBinError(binpPb)<<" (DSYS=+"<<grRadiiC2Sys_pPb->GetErrorYhigh(cb)<<", -"<<grRadiiC2Sys_pPb->GetErrorYlow(cb)<<"); ";
    cout<<LambdaC2pPb->GetBinContent(binpPb)<<" +- "<<LambdaC2pPb->GetBinError(binpPb)<<" (DSYS=+"<<grLambdaC2Sys_pPb->GetErrorYhigh(cb)<<", -"<<grLambdaC2Sys_pPb->GetErrorYlow(cb)<<"); ";
    cout<<RadiipPb->GetBinContent(binpPb)<<" +- "<<RadiipPb->GetBinError(binpPb)<<" (DSYS="<<grRadiiSys_pPb->GetErrorY(cb)<<"); ";
    cout<<LambdapPb->GetBinContent(binpPb)<<" +- "<<LambdapPb->GetBinError(binpPb)<<" (DSYS="<<grLambdaSys_pPb->GetErrorY(cb)<<");"<<endl;
    // Gaussian lambdas
    //cout<<meanNchpPb[cb]-(0.05)*meanNchpPb[cb]<<"  "<<meanNchpPb[cb]+(0.05)*meanNchpPb[cb]<<"     "<<LambdaC2pPb->GetBinContent(binpPb)<<"     "<<LambdaC2pPb->GetBinError(binpPb)<<"     "<<grLambdaC2Sys_pPb->GetErrorY(cb)<<"           "<<LambdapPb->GetBinContent(binpPb)<<"     "<<LambdapPb->GetBinError(binpPb)<<"     "<<grLambdaSys_pPb->GetErrorY(cb)<<endl;
    // Edgeworth lambdas
    //cout<<meanNchpPb[cb]-(0.05)*meanNchpPb[cb]<<"  "<<meanNchpPb[cb]+(0.05)*meanNchpPb[cb]<<"     "<<LambdaC2pPb->GetBinContent(binpPb)<<"     "<<LambdaC2pPb->GetBinError(binpPb)<<"     "<<grLambdaC2Sys_pPb->GetErrorYhigh(cb)<<"     "<<grLambdaC2Sys_pPb->GetErrorYlow(cb)<<"           "<<LambdapPb->GetBinContent(binpPb)<<"     "<<LambdapPb->GetBinError(binpPb)<<"     "<<grLambdaSys_pPb->GetErrorY(cb)<<endl;
  }
  cout<<endl;
  cout<<"Pb--Pb:"<<endl;
  for(int cb=19; cb>=0; cb--){
    int binPbPb = RadiiC2PbPb->GetXaxis()->FindBin(meanNchPbPb[cb]);
    if(RadiiPbPb->GetBinContent(binPbPb)==0) continue;
    cout<<meanNchPbPb[cb]-(0.05)*meanNchPbPb[cb]<<" TO "<<meanNchPbPb[cb]+(0.05)*meanNchPbPb[cb]<<"; "<<RadiiC2PbPb->GetBinContent(binPbPb)<<" +- "<<RadiiC2PbPb->GetBinError(binPbPb)<<" (DSYS=+"<<grRadiiC2Sys_PbPb->GetErrorYhigh(cb)<<", -"<<grRadiiC2Sys_PbPb->GetErrorYlow(cb)<<"); ";
    cout<<LambdaC2PbPb->GetBinContent(binPbPb)<<" +- "<<LambdaC2PbPb->GetBinError(binPbPb)<<" (DSYS=+"<<grLambdaC2Sys_PbPb->GetErrorYhigh(cb)<<", -"<<grLambdaC2Sys_PbPb->GetErrorYlow(cb)<<"); ";
    cout<<RadiiPbPb->GetBinContent(binPbPb)<<" +- "<<RadiiPbPb->GetBinError(binPbPb)<<" (DSYS="<<grRadiiSys_PbPb->GetErrorY(cb)<<"); ";
    cout<<LambdaPbPb->GetBinContent(binPbPb)<<" +- "<<LambdaPbPb->GetBinError(binPbPb)<<" (DSYS="<<grLambdaSys_PbPb->GetErrorY(cb)<<");"<<endl;
    //
    //cout<<meanNchPbPb[cb]-(0.05)*meanNchPbPb[cb]<<"  "<<meanNchPbPb[cb]+(0.05)*meanNchPbPb[cb]<<"     "<<LambdaC2PbPb->GetBinContent(binPbPb)<<"     "<<LambdaC2PbPb->GetBinError(binPbPb)<<"     "<<grLambdaC2Sys_PbPb->GetErrorY(cb)<<"           "<<LambdaPbPb->GetBinContent(binPbPb)<<"     "<<LambdaPbPb->GetBinError(binPbPb)<<"     "<<grLambdaSys_PbPb->GetErrorY(cb)<<endl;
  }
  cout<<endl;
  
    

  
  can3->cd();
  TPad *pad3_2 = new TPad("pad3_2","pad3_2",0.0,0.0,1.,1.);
  pad3_2->SetFillStyle(0);
  pad3_2->Draw();
  pad3_2->cd();
  TLatex *RinvTitle;
  if(FitType==0) RinvTitle=new TLatex(0.062,0.72,"#font[12]{R}^{#font[12]{G}}_{inv} or #font[12]{R}^{#font[12]{G}}_{inv,3} (fm)");
  else if(FitType==1) RinvTitle=new TLatex(0.062,0.72,"#font[12]{R}^{#font[12]{E}_{w}}_{inv} or #font[12]{R}^{#font[12]{E}_{w}}_{inv,3} (fm)");
  else RinvTitle=new TLatex(0.062,0.61,"(#font[12]{R}^{Exp}_{inv} or #font[12]{R}^{Exp}_{inv,3}) / #sqrt{#pi} (fm)");
  RinvTitle->SetNDC();
  RinvTitle->SetTextFont(TextFont);
  RinvTitle->SetTextSize(SizeTitle);
  RinvTitle->SetTextAngle(90);
  RinvTitle->Draw("same");
  TLatex *LambdaTitle;
  if(FitType==0) LambdaTitle=new TLatex(0.064,0.31,"#lambda^{#font[12]{G}}_{e} or #lambda^{#font[12]{G}}_{e,3}");// 0.064,0.33
  else if(FitType==1) LambdaTitle=new TLatex(0.064,0.31,"#lambda^{#font[12]{E}_{w}}_{e} or #lambda^{#font[12]{E}_{w}}_{e,3}");// 0.064,0.33
  else LambdaTitle=new TLatex(0.064,0.31,"#lambda^{Exp}_{e} or #lambda^{Exp}_{e,3}");// 0.064,0.33
  LambdaTitle->SetNDC();
  LambdaTitle->SetTextFont(TextFont);
  LambdaTitle->SetTextSize(SizeTitle);
  LambdaTitle->SetTextAngle(90);
  LambdaTitle->Draw("same");
  

  if(SaveFiles && FitType==0) can3->SaveAs("ThreePionFitParametersGauss.eps");
  if(SaveFiles && FitType==1) can3->SaveAs("ThreePionFitParametersEW.eps");


  
  ///////////////////////////////////////////////////////////////////////////////
  ///////////////////////////////////////////////////////////////////////////////
  // kappa plots
  /*
  TCanvas *can7 = new TCanvas("can7", "can7",1700,700,600,600);// 11,53,700,500
  can7->SetHighLightColor(2);
  gStyle->SetOptFit(0);// 0111 to show fit stat box
  can7->SetFillColor(0);//10
  can7->SetBorderMode(0);
  can7->SetBorderSize(2);
  can7->SetFrameFillColor(0);
  can7->SetFrameBorderMode(0);
  can7->SetFrameBorderMode(0);
  can7->cd();
  TPad *pad7 = new TPad("pad7","pad7",0.0,0.0,1.,1.);
  gPad->SetGridx(0);
  gPad->SetGridy(1);
  pad7->SetTopMargin(0.02);//0.05
  pad7->SetRightMargin(0.02);//3e-2
  pad7->SetBottomMargin(0.1);//0.12
  pad7->SetLeftMargin(0.1);//0.12
  pad7->Draw();
  pad7->cd();
  gPad->SetLogx();
  gPad->SetGridy(1);
  TLegend *legend8 = new TLegend(.2,.70, .4,.95,NULL,"brNDC");//.45 or .4 for x1
  legend8->SetBorderSize(0);
  legend8->SetFillColor(0);
  legend8->SetTextFont(TextFont);
  legend8->SetTextSize(SizeLegend);
  // CollType, Gaussian/EW, EDbin, Parameter#
  int paramNum=4;
  Parameters_c3[0][1][KT3Bin][paramNum]->GetXaxis()->SetTitleOffset(1.2); Parameters_c3[0][1][KT3Bin][paramNum]->GetYaxis()->SetTitleOffset(1.4);
  if(paramNum==3) {Parameters_c3[0][1][KT3Bin][paramNum]->SetMinimum(-0.1); Parameters_c3[0][1][KT3Bin][paramNum]->SetMaximum(.4);}
  if(paramNum==4) {Parameters_c3[0][1][KT3Bin][paramNum]->SetMinimum(-0.1); Parameters_c3[0][1][KT3Bin][paramNum]->SetMaximum(1.0);}
  Parameters_c3[0][1][KT3Bin][paramNum]->Draw();
  Parameters_c3[1][1][KT3Bin][paramNum]->Draw("same");
  Parameters_c3[2][1][KT3Bin][paramNum]->Draw("same");
  legend8->AddEntry(Parameters_c3[2][1][KT3Bin][paramNum],"pp #sqrt{s}=7 TeV","p");
  legend8->AddEntry(Parameters_c3[1][1][KT3Bin][paramNum],"p-Pb #sqrt{#font[12]{s}_{NN}}=5.02 TeV","p");
  legend8->AddEntry(Parameters_c3[0][1][KT3Bin][paramNum],"Pb-Pb #sqrt{#font[12]{s}_{NN}}=2.76 TeV","p");
  //legend8->Draw("same");
  //for(int ct=0; ct<3; ct++){ 
    //for(int cb=0; cb<20; cb++){
      //int bin = 0;
      //if(ct==0) bin = Parameters_c3[ct][1][KT3Bin][paramNum]->GetXaxis()->FindBin(meanNchPbPb[cb]);
      //else if(ct==1) bin = Parameters_c3[ct][1][KT3Bin][paramNum]->FindBin(meanNchpPb[cb]);
      //else bin = Parameters_c3[ct][1][KT3Bin][paramNum]->FindBin(meanNchpp[cb]);
      //
      //if(Parameters_c3[ct][1][KT3Bin][paramNum]->GetBinError(bin) >0) {
	//cout<<Parameters_c3[ct][1][KT3Bin][paramNum]->GetBinContent(bin)<<", ";
	//cout<<Parameters_c3[ct][1][KT3Bin][paramNum]->GetBinError(bin)<<", ";
      //}else cout<<0<<", ";
      
    //}
    //cout<<endl;
    //}
  
  
  
  TH1D *Combined_kappaPlot_1=(TH1D*)Parameters_c3[0][1][KT3Bin][paramNum]->Clone();
  Combined_kappaPlot_1->Add(Parameters_c3[1][1][KT3Bin][paramNum]);
  Combined_kappaPlot_1->Add(Parameters_c3[2][1][KT3Bin][paramNum]);
 
  //TF1 *Fit_kappa3_PbPb=new TF1("Fit_kappa3_PbPb","[0]+[1]*log(x)",2,3000);
  //Fit_kappa3_PbPb->SetParameter(0, 0.05);
  //Fit_kappa3_PbPb->SetParameter(1, -0.01);
  //Fit_kappa3_PbPb->SetLineColor(1);
  
  //
  //TF1 *Fit_kappa3_pp=new TF1("Fit_kappa3_pp","[0]+[1]*log(x)",1,3000);
  //Fit_kappa3_pp->SetParameter(0, 0.05);
  //Fit_kappa3_pp->SetParameter(1, -0.01);
  //Fit_kappa3_pp->SetLineColor(3);
  //Combined_kappaPlot_1->Fit(Fit_kappa3_pp,"IMEN","",2,80);
  //Fit_kappa3_pp->Draw("same");
  //
  TF1 *Fit_kappa4_PbPb=new TF1("Fit_kappa4_PbPb","pol0",2,3000);
  Combined_kappaPlot_1->Fit(Fit_kappa4_PbPb,"IMEN","",2,2000);
  Fit_kappa4_PbPb->Draw("same");
  */


  ////////////////////////////////////////////////////
  ////////////////////////////////////////////////////
  // Radii ratios
  if(NchOneThirdAxis){
    TCanvas *can6 = new TCanvas("can6", "can6",1700,700,600,600);// 11,53,700,500
    can6->SetHighLightColor(2);
    gStyle->SetOptFit(0);// 0111 to show fit stat box
    can6->SetFillColor(0);//10
    can6->SetBorderMode(0);
    can6->SetBorderSize(2);
    can6->SetFrameFillColor(0);
    can6->SetFrameBorderMode(0);
    can6->SetFrameBorderMode(0);
    can6->cd();
    TPad *pad6 = new TPad("pad6","pad6",0.0,0.0,1.,1.);
    gPad->SetGridx(0);
    gPad->SetGridy(0);
    pad6->SetTopMargin(0.0);//0.05
    pad6->SetRightMargin(0.0);//3e-2
    pad6->SetBottomMargin(0.0);//0.12
    pad6->SetLeftMargin(0.0);//0.12
    pad6->Draw();
    pad6->cd();
    TLegend *legend8 = new TLegend(.52,.3, .9,.5,NULL,"brNDC");//.45 or .4 for x1
    legend8->SetBorderSize(0);
    legend8->SetFillColor(0);
    legend8->SetTextFont(TextFont);
    legend8->SetTextSize(SizeLegend);
    gPad->SetRightMargin(0.01); gPad->SetLeftMargin(0.14);
    gPad->SetBottomMargin(0.14); gPad->SetTopMargin(0.02);
    gPad->SetTickx(); gPad->SetTicky();
    
    TH1D *Ratio_pPb_to_pp=(TH1D*)RadiipPb->Clone();
    TH1D *Ratio_PbPb_to_pPb=(TH1D*)RadiiC2PbPb->Clone();
    double avgRatio_pPb_to_pp=0, avgRatioSq_pPb_to_pp=0, avgRatioStat_pPb_to_pp=0,  avgRatioEn_pPb_to_pp=0;
    double avgRatio_PbPb_to_pPb=0, avgRatioSq_PbPb_to_pPb=0, avgRatioStat_PbPb_to_pPb=0, avgRatioEn_PbPb_to_pPb=0;
    for(int cb=0; cb<20; cb++){// 3-particle
      int binPbPb = RadiiPbPb->GetXaxis()->FindBin(meanNchPbPb[cb]);
      int binpPb = RadiipPb->GetXaxis()->FindBin(meanNchpPb[cb]);
      //
      Ratio_pPb_to_pp->SetBinContent(binpPb, Ratio_pPb_to_pp->GetBinContent(binpPb) / ppLine->Eval(meanNchpPb[cb]));
      Ratio_PbPb_to_pPb->SetBinContent(binPbPb, Ratio_PbPb_to_pPb->GetBinContent(binPbPb) / pPbLine->Eval(meanNchPbPb[cb]));
      //
      if(cb<=18 && cb>=14){
	avgRatio_pPb_to_pp += Ratio_pPb_to_pp->GetBinContent(binpPb);
	avgRatioSq_pPb_to_pp += pow(Ratio_pPb_to_pp->GetBinContent(binpPb),2);
	avgRatioStat_pPb_to_pp += pow(Ratio_pPb_to_pp->GetBinError(binpPb),2);
	avgRatioEn_pPb_to_pp++;
      }
      if(cb<=15 && cb>=13){
	avgRatio_PbPb_to_pPb += Ratio_PbPb_to_pPb->GetBinContent(binPbPb);
	avgRatioSq_PbPb_to_pPb += pow(Ratio_PbPb_to_pPb->GetBinContent(binPbPb),2);
	avgRatioStat_PbPb_to_pPb += pow(Ratio_PbPb_to_pPb->GetBinError(binPbPb),2);
	avgRatioEn_PbPb_to_pPb++;
      }
    }
    Ratio_pPb_to_pp->SetMinimum(0.9); Ratio_pPb_to_pp->SetMaximum(1.65);
    Ratio_pPb_to_pp->GetYaxis()->SetTitle("Radius ratio");
    Ratio_pPb_to_pp->GetXaxis()->SetLabelSize(SizeLabel); Ratio_pPb_to_pp->GetYaxis()->SetLabelSize(SizeLabel);
    Ratio_pPb_to_pp->GetXaxis()->SetTitleSize(SizeTitle); Ratio_pPb_to_pp->GetYaxis()->SetTitleSize(SizeTitle);
    Ratio_pPb_to_pp->GetXaxis()->SetTitleOffset(1.0); 
    Ratio_pPb_to_pp->GetYaxis()->SetTitleOffset(1.2); 
    Ratio_pPb_to_pp->GetXaxis()->SetNdivisions(808);
    Ratio_pPb_to_pp->GetYaxis()->SetNdivisions(505);
    Ratio_pPb_to_pp->Draw();
    Ratio_PbPb_to_pPb->Draw("same");
    legend8->AddEntry(Ratio_pPb_to_pp,"p-Pb over pp","p");
    legend8->AddEntry(Ratio_PbPb_to_pPb,"Pb-Pb over p-Pb","p");
    legend8->Draw("same");
    Unity->Draw("same");
    
    double avgStat_pPb_to_pp = sqrt(avgRatioStat_pPb_to_pp/avgRatioEn_pPb_to_pp);
    double RMS_pPb_to_pp = sqrt( (avgRatioSq_pPb_to_pp/avgRatioEn_pPb_to_pp - pow(avgRatio_pPb_to_pp/avgRatioEn_pPb_to_pp,2)) / avgRatioEn_pPb_to_pp );
    double avgStat_PbPb_to_pPb = sqrt(avgRatioStat_PbPb_to_pPb/avgRatioEn_PbPb_to_pPb);
    double RMS_PbPb_to_pPb = sqrt( (avgRatioSq_PbPb_to_pPb/avgRatioEn_PbPb_to_pPb - pow(avgRatio_PbPb_to_pPb/avgRatioEn_PbPb_to_pPb,2)) / avgRatioEn_PbPb_to_pPb );
    cout.precision(4);
    cout<<"avg Ratio of pPb to pp = "<<avgRatio_pPb_to_pp/avgRatioEn_pPb_to_pp<<" +- "<<sqrt(pow(avgStat_pPb_to_pp,2) + pow(RMS_pPb_to_pp,2))<<endl;
    cout<<"avg Ratio of PbPb to pPb = "<<avgRatio_PbPb_to_pPb/avgRatioEn_PbPb_to_pPb<<" +- "<<sqrt(pow(avgStat_PbPb_to_pPb,2) + pow(RMS_PbPb_to_pPb,2))<<endl;
  }  
  
  
  if(KT3Bin>0) {cout<<"Skip the rest for this setting"<<endl; return;}
  
  ////////////////////////////////////////////////////
  ////////////////////////////////////////////////////
  // Correlation functions and Monte Carlo
  TCanvas *can4 = (TCanvas*)make_canvas("can4","can4",3,2,0,900,600);
  can4->Draw();

  TLegend *legend5[6];
  legend5[0] = new TLegend(.3,.52, .97,.99,NULL,"brNDC");//.45 or .4 for x1
  legend5[0]->SetBorderSize(0);
  legend5[0]->SetFillColor(0);
  legend5[0]->SetTextFont(TextFont);
  legend5[1]=(TLegend*)legend5[0]->Clone();
  legend5[2]=(TLegend*)legend5[0]->Clone();
  legend5[3]=(TLegend*)legend5[0]->Clone();
  legend5[4]=(TLegend*)legend5[0]->Clone();
  legend5[5]=(TLegend*)legend5[0]->Clone();
  TLegend *legendFitTypes = (TLegend*)legend5[0]->Clone();
  
  
  double HIJING_c3_SC_K1_M3[15]={0, 0.851168, 0.979088, 1.0209, 0.976797, 1.01555, 0.992262, 1.00773, 0.991634, 0.991504, 0.997317, 0.993006, 0.99694, 0.999369, 0.998404};
  double HIJING_c3_SC_K1_M3_e[15]={0, 0.546937, 0.118551, 0.0436675, 0.0226652, 0.0139659, 0.00906562, 0.00649369, 0.00488794, 0.00380819, 0.00306916, 0.00255166, 0.00219781, 0.00235171, 0.00292962};
  double HIJING_c3_MC_K1_M3[15]={0, 0.886712, 1.02583, 0.985831, 1.00453, 1.01572, 1.00153, 0.991872, 0.997636, 0.997151, 0.996838, 0.999562, 0.998487, 0.996162, 1.001};
  double HIJING_c3_MC_K1_M3_e[15]={0, 0.190786, 0.0527107, 0.0220311, 0.0119954, 0.00756783, 0.00499146, 0.00360927, 0.0027377, 0.00214376, 0.00173608, 0.00144723, 0.00124891, 0.00133898, 0.0016771};
  TH1D *HIJING_c3_SC=(TH1D*)c3[1][1][0][0][17]->Clone();// choose any one that exists to copy histo attributes
  TH1D *HIJING_c3_MC=(TH1D*)c3[1][1][0][0][17]->Clone();// choose any one that exists to copy histo attributes
  for(int i=1; i<=15; i++){
    HIJING_c3_SC->SetBinContent(i, HIJING_c3_SC_K1_M3[i-1]);
    HIJING_c3_SC->SetBinError(i, HIJING_c3_SC_K1_M3_e[i-1]);
    HIJING_c3_MC->SetBinContent(i, HIJING_c3_MC_K1_M3[i-1]);
    HIJING_c3_MC->SetBinError(i, HIJING_c3_MC_K1_M3_e[i-1]);
  }
  cout.precision(4);
  //
  for(int padNum=1; padNum<=6; padNum++){
   
    can4->cd(padNum);
    if(padNum==3 || padNum==6) gPad->SetRightMargin(0.005);
    float SF_6pannel=2;
    double SF_correction=1.0;
    if(padNum==3) SF_correction=1.1;
    if(padNum==4) SF_correction=0.8;
    if(padNum==5 || padNum==6) SF_correction=0.92;
    
    //
    int System_proof=0;
    int ChComb_proof=0;
    int Mb_proof=0;
    if(padNum==1) {System_proof=2; ChComb_proof=0; Mb_proof=18;}
    if(padNum==2) {System_proof=1; ChComb_proof=0; Mb_proof=14;}
    if(padNum==3) {System_proof=0; ChComb_proof=0; Mb_proof=3;}
    if(padNum==4) {System_proof=2; ChComb_proof=1; Mb_proof=18;}
    if(padNum==5) {System_proof=1; ChComb_proof=1; Mb_proof=14;}
    if(padNum==6) {System_proof=0; ChComb_proof=1; Mb_proof=3;}
    
    // print out data points
    for(int binN=1; binN<=C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetNbinsX(); binN++){
      cout<<C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetXaxis()->GetBinLowEdge(binN)<<" TO "<<C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetXaxis()->GetBinUpEdge(binN)<<"; "<<C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetBinContent(binN)<<" +- "<<C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetBinError(binN)<<" (DSYS="<<C3_Sys[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetBinError(binN)<<"); "<<c3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetBinContent(binN)<<" +- "<<c3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetBinError(binN)<<" (DSYS="<<c3_Sys[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetBinError(binN)<<"); ";
      if(System_proof==0){
	cout<<HIJING_c3_SC->GetBinContent(binN)<<" +- "<<HIJING_c3_SC->GetBinError(binN)<<"; - ;"<<endl;
      }else{
	cout<<c3[System_proof][1][ChComb_proof][KT3Bin][Mb_proof]->GetBinContent(binN)<<" +- "<<c3[System_proof][1][ChComb_proof][KT3Bin][Mb_proof]->GetBinError(binN)<<"; - ;"<<endl;
      }
    }
    cout<<endl;
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->SetMinimum(0.9); 
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->SetMaximum(3.4);// 3.4
    //
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetYaxis()->SetTitle("#font[12]{C}_{3} or #font[12]{#bf{c}}_{3} ");
    if(padNum<=5){
      C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetXaxis()->SetTitleOffset(10); 
    }else C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetXaxis()->SetTitleOffset(0.88);
    if(padNum==1) C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetYaxis()->SetTitleOffset(0.55);
    else C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetYaxis()->SetTitleOffset(10.);
    if(padNum>=5) C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetXaxis()->SetLabelOffset(-.0);

    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetXaxis()->SetNdivisions(504);
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetYaxis()->SetNdivisions(504);
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetXaxis()->SetTitleSize(SizeTitle*SF_6pannel*SF_correction);
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetYaxis()->SetTitleSize(SizeTitle*SF_6pannel*SF_correction);
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetXaxis()->SetLabelSize(SizeTitle*SF_6pannel*SF_correction);
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetYaxis()->SetLabelSize(SizeTitle*SF_6pannel*SF_correction);
    double Q3Limit;
    if(System_proof==1 || System_proof==2) Q3Limit = 0.49;
    else Q3Limit = 0.1099;
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->GetXaxis()->SetRangeUser(0,Q3Limit);
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->DrawCopy();
    
        
    C3_Sys[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->DrawCopy("E2 same");
    c3_Sys[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->DrawCopy("E2 same");
    C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->DrawCopy("same");
    c3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof]->DrawCopy("same");
    if(System_proof!=0) c3[System_proof][1][ChComb_proof][KT3Bin][Mb_proof]->DrawCopy("same");// MC cumulants
    else{
      if(ChComb_proof==0) HIJING_c3_SC->DrawCopy("same");
      else HIJING_c3_MC->DrawCopy("same");
    }
    if(padNum<=3){
      legend5[padNum-1]->AddEntry(C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof],"#font[12]{C}_{3}^{#pm#pm#pm}","p");
      legend5[padNum-1]->AddEntry(c3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof],"#font[12]{#bf{c}}_{3}^{#pm#pm#pm}","p");
    }else{
      legend5[padNum-1]->AddEntry(C3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof],"#font[12]{C}_{3}^{#pm#pm#mp}","p");
      legend5[padNum-1]->AddEntry(c3[System_proof][0][ChComb_proof][KT3Bin][Mb_proof],"#font[12]{#bf{c}}_{3}^{#pm#pm#mp}","p");
      if(System_proof==0) legend5[padNum-1]->AddEntry(HIJING_c3_MC,"HIJING #font[12]{#bf{c}}_{3}","p");
      if(System_proof==1) legend5[padNum-1]->AddEntry(c3[System_proof][1][ChComb_proof][KT3Bin][Mb_proof],"DPMJET #font[12]{#bf{c}}_{3}","p");
      if(System_proof==2) legend5[padNum-1]->AddEntry(c3[System_proof][1][ChComb_proof][KT3Bin][Mb_proof],"PYTHIA #font[12]{#bf{c}}_{3}","p");
    }
   
    if(ChComb_proof==0) {
      c3_fit[System_proof][0][KT3Bin][Mb_proof]->Draw("c same");// Gauss
      gr_c3Spline[System_proof][KT3Bin][Mb_proof]->Draw("c same");// EW with spline for mid-q and high q
      gr_c3SplineExpFit[System_proof][KT3Bin][Mb_proof]->Draw("c same");// Exp
      //c3_fit[System_proof][1][KT3Bin][Mb_proof]->Draw("c same");// old approximation
      if(padNum==3){
	legendFitTypes->AddEntry(c3_fit[System_proof][0][KT3Bin][Mb_proof],"Gaussian","l");
	legendFitTypes->AddEntry(c3_fit[System_proof][1][KT3Bin][Mb_proof],"Edgeworth","l");
	legendFitTypes->AddEntry(c3_fit[System_proof][2][KT3Bin][Mb_proof],"Exponential","l");
      }
    }
    
    TLatex *CTLabel;
    if(System_proof==0) CTLabel = new TLatex(0.12,0.9,"Pb-Pb #sqrt{#font[12]{s}_{NN}}=2.76 TeV");// 0.003,.988
    if(System_proof==1) CTLabel = new TLatex(0.15,0.9,"p-Pb #sqrt{#font[12]{s}_{NN}}=5.02 TeV");// 0.003,.988
    if(System_proof==2) CTLabel = new TLatex(0.4,0.9,"pp #sqrt{s}=7 TeV");// 0.003,.988
    CTLabel->SetNDC();
    CTLabel->SetTextFont(TextFont);
    CTLabel->SetTextSize(SizeSpecif*SF_6pannel*SF_correction);
    if(padNum>=4) CTLabel->Draw("same");
    
    TString *nameCh=new TString("#LT#font[12]{N}_{ch}#GT = ");
    float Nch=1;
    if(System_proof==0) Nch = meanNchPbPb[Mb_proof];
    else if(System_proof==1) Nch = meanNchpPb[Mb_proof];
    else Nch = meanNchpp[Mb_proof];
    *nameCh += int(Nch + 0.5);
    nameCh->Append(" #pm ");
    float SysPercent = 0.05;
    int SigFig=0;
    if(SysPercent*Nch < 1) {nameCh->Append("0."); SigFig=int(10*SysPercent*Nch + 0.5);}
    else {SigFig=int(SysPercent*Nch + 0.5);}
    
    *nameCh += SigFig;
    TLatex *MLabel;
    if(padNum==1) MLabel = new TLatex(0.45,0.6,"#LT#font[12]{N}_{ch}#GT = 8.6 #pm 0.4");// was nameCh->Data()
    if(padNum==2) MLabel = new TLatex(0.4,0.6,nameCh->Data());
    if(padNum==3) MLabel = new TLatex(0.4,0.6,nameCh->Data());
    
    MLabel->SetNDC();
    MLabel->SetTextFont(TextFont);
    MLabel->SetTextSize(SizeSpecif*SF_6pannel*SF_correction);
    if(padNum<=3) MLabel->Draw("same");
    
    
    legend5[padNum-1]->SetTextSize(SizeLegend*SF_6pannel*SF_correction);
    if(padNum==1) {legend5[padNum-1]->SetX1(0.45); legend5[padNum-1]->SetY1(0.69);}
    if(padNum==2) {legend5[padNum-1]->SetX1(0.32); legend5[padNum-1]->SetY1(0.69);}
    if(padNum==3) {
      legend5[padNum-1]->SetX1(0.32); legend5[padNum-1]->SetY1(0.69);
      legendFitTypes->SetX1(0.44); 
      legendFitTypes->SetY1(0.22); legendFitTypes->SetY2(0.56);
      legendFitTypes->Draw("same");
    }
    if(padNum==4) {legend5[padNum-1]->SetX1(0.45); legend5[padNum-1]->SetY1(0.45); legend5[padNum-1]->SetY2(0.85);}
    if(padNum==5) {legend5[padNum-1]->SetX1(0.32); legend5[padNum-1]->SetY1(0.45); legend5[padNum-1]->SetY2(0.85);}
    if(padNum==6) {legend5[padNum-1]->SetX1(0.32); legend5[padNum-1]->SetY1(0.45); legend5[padNum-1]->SetY2(0.85);}
    legend5[padNum-1]->Draw("same");
  }
  
  
  
  can4->cd();
  
  TPad *pad4_2 = new TPad("pad4_2","pad4_2",0.0,0.0,1.,1.);
  pad4_2->SetFillStyle(0);
  pad4_2->Draw();
  pad4_2->cd();
  TBox *CoverUp1 = new TBox(0.35,0.05,0.42,.115);
  CoverUp1->SetFillColor(0);
  CoverUp1->Draw();
  TBox *CoverUp2 = new TBox(0.66,0.05,0.73,.115);
  CoverUp2->SetFillColor(0);
  CoverUp2->Draw();
  
  

 
  
  ////////////////////////////////////////////////////
  ////////////////////////////////////////////////////
  // 2 system correlation function comparison
  TCanvas *can5 = new TCanvas("can5", "can5",1700,700,600,600);// 11,53,700,500
  can5->SetHighLightColor(2);
  gStyle->SetOptFit(0);// 0111 to show fit stat box
  can5->SetFillColor(0);//10
  can5->SetBorderMode(0);
  can5->SetBorderSize(2);
  can5->SetFrameFillColor(0);
  can5->SetFrameBorderMode(0);
  can5->SetFrameBorderMode(0);
  can5->cd();
  TPad *pad5 = new TPad("pad5","pad5",0.0,0.0,1.,1.);
  gPad->SetGridx(0);
  gPad->SetGridy(0);
  pad5->SetTopMargin(0.0);//0.05
  pad5->SetRightMargin(0.0);//3e-2
  pad5->SetBottomMargin(0.0);//0.12
  pad5->SetLeftMargin(0.0);//0.12
  pad5->Draw();
  pad5->cd();
  TLegend *legend6 = new TLegend(.42,.6, .9,.95,NULL,"brNDC");//.45 or .4 for x1
  legend6->SetBorderSize(0);
  legend6->SetFillColor(0);
  legend6->SetTextFont(TextFont);
  legend6->SetTextSize(SizeLegend);
  TLegend *legend7 = new TLegend(.66,.36, .97,.53,NULL,"brNDC");//.45 or .4 for x1
  legend7->SetBorderSize(0);
  legend7->SetFillColor(0);
  legend7->SetTextFont(TextFont);
  legend7->SetTextSize(SizeLegend);
  //
  gPad->SetRightMargin(0.01); gPad->SetLeftMargin(0.10);
  gPad->SetBottomMargin(0.14); gPad->SetTopMargin(0.02);
  gPad->SetTickx(); gPad->SetTicky();
  //
  int KT3Bin_CorrComp=0;
  int Mbin_SysComp_PbPb=12;// 12
  int Mbin_SysComp_pPb;
  int Mbin_SysComp_pp=15;// 15
  if(pp_pPb_Comp) Mbin_SysComp_pPb=16;// 16 
  else Mbin_SysComp_pPb=12;// 12

  TH1D *c3_PbPb=(TH1D*)c3[0][0][0][KT3Bin_CorrComp][Mbin_SysComp_PbPb]->Clone();
  TH1D *c3_pPb=(TH1D*)c3[1][0][0][KT3Bin_CorrComp][Mbin_SysComp_pPb]->Clone();
  TH1D *c3_pp=(TH1D*)c3[2][0][0][KT3Bin_CorrComp][Mbin_SysComp_pp]->Clone();

  c3_pPb->GetYaxis()->SetTitle("#bf{c}_{3}^{#pm#pm#pm}");
  c3_pPb->GetXaxis()->SetRangeUser(0,0.27);
  
  c3_pPb->GetXaxis()->SetLabelSize(SizeLabel); c3_pPb->GetYaxis()->SetLabelSize(SizeLabel);
  c3_pPb->GetXaxis()->SetTitleSize(SizeTitle); c3_pPb->GetYaxis()->SetTitleSize(SizeTitle);
  
  c3_pPb->GetYaxis()->SetTitle("#font[12]{#bf{c}}_{3}^{#pm#pm#pm}");
  c3_pPb->GetXaxis()->SetTitleOffset(1.0); 
  c3_pPb->GetYaxis()->SetTitleOffset(0.7); 
  c3_pPb->SetMinimum(0.9); 
  c3_pPb->SetMaximum(3.3);// 3.3
  c3_pPb->GetXaxis()->SetNdivisions(503);
  c3_pPb->GetYaxis()->SetNdivisions(503);
  c3_pPb->SetMarkerStyle(25);

  c3_pPb->Draw();
  //
  if(pp_pPb_Comp) c3_Sys[2][0][0][KT3Bin_CorrComp][Mbin_SysComp_pp]->Draw("E2 same");
  c3_Sys[1][0][0][KT3Bin_CorrComp][Mbin_SysComp_pPb]->Draw("E2 same");
  if(!pp_pPb_Comp) c3_Sys[0][0][0][KT3Bin][Mbin_SysComp_PbPb]->Draw("E2 same");
  if(pp_pPb_Comp) c3_pp->Draw("same");
  c3_pPb->Draw("same");
  if(!pp_pPb_Comp) c3_PbPb->Draw("same");
  
  if(pp_pPb_Comp) {
    legend6->AddEntry(c3_pPb,"#splitline{p-Pb #sqrt{#font[12]{s}_{NN}}=5.02 TeV}{#LT#font[12]{N}_{ch}#GT = 23 #pm 1}","p");// MpPb=16, Nch=23
    legend6->AddEntry(c3_pp,"#splitline{pp #sqrt{s}=7 TeV}{#LT#font[12]{N}_{ch}#GT = 27 #pm 1}","p");// Mpp=15, Nch=27
  }else{
    legend6->AddEntry(c3_pPb,"#splitline{p-Pb #sqrt{#font[12]{s}_{NN}}=5.02 TeV}{#LT#font[12]{N}_{ch}#GT = 71 #pm 4}","p");// MpPb=12, Nch=71
    legend6->AddEntry(c3_PbPb,"#splitline{Pb-Pb #sqrt{#font[12]{s}_{NN}}=2.76 TeV}{#LT#font[12]{N}_{ch}#GT = 84 #pm 4}","p");// MPbPb=12, Nch=84
  }
  
  //
  
  if(!pp_pPb_Comp) c3_fit[0][0][KT3Bin][Mbin_SysComp_PbPb]->Draw("c same");
  c3_fit[1][0][KT3Bin][Mbin_SysComp_pPb]->Draw("c same");
  if(pp_pPb_Comp) c3_fit[2][0][KT3Bin][Mbin_SysComp_pp]->Draw("c same");
  //
  TF1 *GaussFit_forLegend=(TF1*)c3_fit[1][0][KT3Bin][Mbin_SysComp_pPb]->Clone();
  TF1 *EwFit_forLegend=(TF1*)c3_fit[1][1][KT3Bin][Mbin_SysComp_pPb]->Clone();
  TF1 *ExpFit_forLegend=(TF1*)c3_fit[1][2][KT3Bin][Mbin_SysComp_pPb]->Clone();
  GaussFit_forLegend->SetLineColor(1);
  EwFit_forLegend->SetLineColor(1);
  ExpFit_forLegend->SetLineColor(1);
  legend7->AddEntry(GaussFit_forLegend,"Gaussian","l");
  legend7->AddEntry(EwFit_forLegend,"Edgeworth","l");
  legend7->AddEntry(ExpFit_forLegend,"Exponential","l");
  //
  
 
  // spline draw
  if(!pp_pPb_Comp) gr_c3Spline[0][KT3Bin][Mbin_SysComp_PbPb]->Draw("c same");
  gr_c3Spline[1][KT3Bin][Mbin_SysComp_pPb]->Draw("c same");
  if(pp_pPb_Comp) gr_c3Spline[2][KT3Bin][Mbin_SysComp_pp]->Draw("c same");
  //

  //exp draw
  if(!pp_pPb_Comp) gr_c3SplineExpFit[0][KT3Bin][Mbin_SysComp_PbPb]->Draw("c same");
  gr_c3SplineExpFit[1][KT3Bin][Mbin_SysComp_pPb]->Draw("c same");
  if(pp_pPb_Comp) gr_c3SplineExpFit[2][KT3Bin][Mbin_SysComp_pp]->Draw("c same");
  //
  

  legend6->Draw("same");
  legend7->Draw("same");
  
  TLatex *Specif_Kt3_4 = new TLatex(0.52,0.55,"0.16<#font[12]{K}_{T,3}<0.3 GeV/#font[12]{c}");
  Specif_Kt3_4->SetNDC();
  Specif_Kt3_4->SetTextFont(TextFont);
  Specif_Kt3_4->SetTextSize(SizeSpecif);
  Specif_Kt3_4->Draw("same");
  
  // print out data points
  for(int binN=1; binN<=c3_pPb->GetNbinsX(); binN++){
    if(pp_pPb_Comp) cout<<c3_pPb->GetXaxis()->GetBinLowEdge(binN)<<" TO "<<c3_pPb->GetXaxis()->GetBinUpEdge(binN)<<"; "<<c3_pp->GetBinContent(binN)<<" +- "<<c3_pp->GetBinError(binN)<<" (DSYS="<<c3_Sys[2][0][0][KT3Bin_CorrComp][Mbin_SysComp_pp]->GetBinError(binN)<<"); "<<c3_pPb->GetBinContent(binN)<<" +- "<<c3_pPb->GetBinError(binN)<<" (DSYS="<<c3_Sys[1][0][0][KT3Bin_CorrComp][Mbin_SysComp_pPb]->GetBinError(binN)<<");"<<endl;
    else cout<<c3_pPb->GetXaxis()->GetBinLowEdge(binN)<<" TO "<<c3_pPb->GetXaxis()->GetBinUpEdge(binN)<<"; "<<c3_pPb->GetBinContent(binN)<<" +- "<<c3_pPb->GetBinError(binN)<<" (DSYS="<<c3_Sys[1][0][0][KT3Bin_CorrComp][Mbin_SysComp_pPb]->GetBinError(binN)<<"); "<<c3_PbPb->GetBinContent(binN)<<" +- "<<c3_PbPb->GetBinError(binN)<<" (DSYS="<<c3_Sys[0][0][0][KT3Bin][Mbin_SysComp_PbPb]->GetBinError(binN)<<");"<<endl;
  }

  //
  if(SaveFiles) {
    TString *name = new TString("c3SystemComp");
    if(FitType==1) name->Append("EW");
    name->Append("_MpPb");
    *name += Mbin_SysComp_pPb;
    name->Append(".eps");
    //
    can5->SaveAs(name->Data());
  }
  











  
  
  ////////////////////////////////////////////////////
  ////////////////////////////////////////////////////
 
  TCanvas *can6 = new TCanvas("can6", "can6",1700,700,600,600);// 11,53,700,500
  can6->SetHighLightColor(2);
  gStyle->SetOptFit(0);// 0111 to show fit stat box
  can6->SetFillColor(0);//10
  can6->SetBorderMode(0);
  can6->SetBorderSize(2);
  can6->SetFrameFillColor(0);
  can6->SetFrameBorderMode(0);
  can6->SetFrameBorderMode(0);
  can6->cd();
  TPad *pad6 = new TPad("pad6","pad6",0.0,0.0,1.,1.);
  gPad->SetGridx(0);
  gPad->SetGridy(0);
  pad6->SetTopMargin(0.0);//0.05
  pad6->SetRightMargin(0.0);//3e-2
  pad6->SetBottomMargin(0.0);//0.12
  pad6->SetLeftMargin(0.0);//0.12
  pad6->Draw();
  pad6->cd();
  TLegend *legend8 = new TLegend(.17,.4, .5,.6,NULL,"brNDC");//.45 or .4 for x1
  legend8->SetBorderSize(0);
  legend8->SetFillColor(0);
  legend8->SetTextFont(TextFont);
  legend8->SetTextSize(0.8*SizeLegend);
  TLegend *legend9 = new TLegend(.17,.6, .6,.98,NULL,"brNDC");//.45 or .4 for x1
  legend9->SetBorderSize(0);
  legend9->SetFillColor(0);
  legend9->SetTextFont(TextFont);
  legend9->SetTextSize(0.8*SizeLegend);
  //
  gPad->SetLeftMargin(0.14);
  gPad->SetRightMargin(0.01);
  gPad->SetTopMargin(0.01);
  gPad->SetBottomMargin(0.14);
  
  gPad->SetTickx(); gPad->SetTicky();
  if(!NchOneThirdAxis) gPad->SetLogx();
  RadiiC2PbPb->GetXaxis()->SetLabelFont(TextFont); RadiiC2PbPb->GetYaxis()->SetLabelFont(TextFont); 
  RadiiC2PbPb->GetXaxis()->SetLabelSize(SizeLabel*SF_2panel); RadiiC2PbPb->GetYaxis()->SetLabelSize(SizeLabel*SF_2panel);
  RadiiC2PbPb->GetXaxis()->SetLabelOffset(-0.01);
  RadiiC2PbPb->GetXaxis()->SetNdivisions(808);
  RadiiC2PbPb->GetXaxis()->SetTitleOffset(1.05);//1.3
  RadiiC2PbPb->GetYaxis()->SetTitleOffset(1.1);//1.1
  RadiiC2PbPb->GetXaxis()->SetTitleFont(TextFont); RadiiC2PbPb->GetXaxis()->SetTitleSize(SizeTitle);// SizeTitle*SF_2panel
  RadiiC2PbPb->GetYaxis()->SetTitleFont(TextFont); RadiiC2PbPb->GetYaxis()->SetTitleSize(SizeTitle);// SizeTitle*SF_2panel
  RadiiC2PbPb->SetMinimum(0.01); RadiiC2PbPb->SetMaximum(11.9);// 0 and 11.9
  //gStyle->SetErrorX(0);
  if(NchOneThirdAxis) RadiiC2PbPb->GetXaxis()->SetRangeUser(0,3000);// 0,3000
  else RadiiC2PbPb->GetXaxis()->SetRangeUser(3,3000);// 3,3000
  //
  //
  Parameters_Bjoern[0][0]->GetXaxis()->SetLabelFont(TextFont); Parameters_Bjoern[0][0]->GetYaxis()->SetLabelFont(TextFont); 
  Parameters_Bjoern[0][0]->GetXaxis()->SetLabelSize(SizeLabel*SF_2panel); Parameters_Bjoern[0][0]->GetYaxis()->SetLabelSize(SizeLabel*SF_2panel);
  Parameters_Bjoern[0][0]->GetXaxis()->SetLabelOffset(-0.01);
  Parameters_Bjoern[0][0]->GetXaxis()->SetNdivisions(808);
  Parameters_Bjoern[0][0]->GetXaxis()->SetTitleOffset(1.05);//1.3
  Parameters_Bjoern[0][0]->GetYaxis()->SetTitleOffset(1.1);//1.1
  Parameters_Bjoern[0][0]->GetXaxis()->SetTitleFont(TextFont); Parameters_Bjoern[0][0]->GetXaxis()->SetTitleSize(SizeTitle);// SizeTitle*SF_2panel
  Parameters_Bjoern[0][0]->GetYaxis()->SetTitleFont(TextFont); Parameters_Bjoern[0][0]->GetYaxis()->SetTitleSize(SizeTitle);// SizeTitle*SF_2panel
  Parameters_Bjoern[0][0]->SetMinimum(0.01); Parameters_Bjoern[0][0]->SetMaximum(8.5);// 0 and 11.9
  //gStyle->SetErrorX(0);
  if(NchOneThirdAxis) Parameters_Bjoern[0][0]->GetXaxis()->SetRangeUser(0,3000);// 0,3000
  else Parameters_Bjoern[0][0]->GetXaxis()->SetRangeUser(3,3000);// 3,3000


  RadiiC2PbPb->GetXaxis()->SetTitle("#LT#font[12]{N}_{ch}#GT");
  RadiiC2PbPb->GetYaxis()->SetTitle("Radius (fm)");
  Parameters_Bjoern[0][0]->GetXaxis()->SetTitle("#LT#font[12]{N}_{ch}#GT");
  Parameters_Bjoern[0][0]->GetYaxis()->SetTitle("Radius (fm)");

  RadiiC2PbPb->Draw();

  
  
  //int HydroCase=0;// 0 or 1
  //Parameters_Bjoern[HydroCase][0]->Draw("same");
  //Parameters_Bjoern[HydroCase][1]->Draw("same");
  //Parameters_Bjoern[HydroCase][2]->Draw("same");

  legend8->AddEntry(RadiiC2pp,"ALICE pp","p");
  legend8->AddEntry(RadiiC2pPb,"ALICE p-Pb","p");
  legend8->AddEntry(RadiiC2PbPb,"ALICE Pb-Pb","p");
  //
  //legend8->AddEntry(Parameters_Bjoern[HydroCase][2],"IP-GLASMA pp (w/o hydro)","p");
  //legend8->AddEntry(Parameters_Bjoern[HydroCase][1],"IP-GLASMA p-Pb (w/o hydro)","p");
  //legend8->AddEntry(Parameters_Bjoern[HydroCase][0],"IP-GLASMA Pb-Pb (w/o hydro)","p");
  
  
  Parameters_Bjoern[0][0]->SetMarkerStyle(24); Parameters_Bjoern[0][1]->SetMarkerStyle(25); Parameters_Bjoern[0][2]->SetMarkerStyle(28);  

  //TMultiGraph *mg = new TMultiGraph();
  //mg->SetTitle("");
  TGraph *Radii_Bjoern[2][3];// Hydro case, CollType
  TGraph *grShade[3];// CollType

  Radii_Bjoern[0][0] = new TGraph(10, Bjoern_xaxis_PbPb, Bjoern_Ri_PbPb[mchoice-1]);
  Radii_Bjoern[0][0]->SetLineWidth(2);
     
  Radii_Bjoern[1][0] = new TGraph(10, Bjoern_xaxis_PbPb, Bjoern_Rhydro_PbPb[mchoice-1]);
  Radii_Bjoern[1][0]->SetLineWidth(2);
  Radii_Bjoern[1][0]->SetLineStyle(2);
  Radii_Bjoern[1][0]->SetFillStyle(1000);
  Radii_Bjoern[1][0]->SetFillColor(kGray);
  grShade[0] = new TGraph(10);
  for(int i=0; i<10; i++){
    grShade[0]->SetPoint(i,Bjoern_xaxis_PbPb[i],Bjoern_Rhydro_PbPb[mchoice-1][i]);
    grShade[0]->SetPoint(10+i,Bjoern_xaxis_PbPb[10-i-1],Bjoern_Ri_PbPb[mchoice-1][10-i-1]);
  }
  grShade[0]->SetFillStyle(1000);
  grShade[0]->SetFillColor(kGray);
  //
  Radii_Bjoern[0][1] = new TGraph(6, Bjoern_xaxis_pPb, Bjoern_Ri_pPb[mchoice-1]);
  Radii_Bjoern[0][1]->SetLineWidth(2);
  Radii_Bjoern[0][1]->SetLineColor(2);
  Radii_Bjoern[1][1] = new TGraph(6, Bjoern_xaxis_pPb, Bjoern_Rhydro_pPb[mchoice-1]);
  Radii_Bjoern[1][1]->SetLineWidth(2);
  Radii_Bjoern[1][1]->SetLineColor(2);
  Radii_Bjoern[1][1]->SetLineStyle(2);
  grShade[1] = new TGraph(6);
  for(int i=0; i<6; i++){
    grShade[1]->SetPoint(i,Bjoern_xaxis_pPb[i],Bjoern_Rhydro_pPb[mchoice-1][i]);
    grShade[1]->SetPoint(6+i,Bjoern_xaxis_pPb[6-i-1],Bjoern_Ri_pPb[mchoice-1][6-i-1]);
  }
  grShade[1]->SetFillStyle(1000);
  grShade[1]->SetFillColor(kRed-10);
  //
  Radii_Bjoern[0][2] = new TGraph(4, Bjoern_xaxis_pp, Bjoern_Ri_pp[mchoice-1]);
  Radii_Bjoern[0][2]->SetLineWidth(2);
  Radii_Bjoern[0][2]->SetLineColor(4);
  Radii_Bjoern[1][2] = new TGraph(4, Bjoern_xaxis_pp, Bjoern_Rhydro_pp[mchoice-1]);
  Radii_Bjoern[1][2]->SetLineWidth(2);
  Radii_Bjoern[1][2]->SetLineColor(4);
  Radii_Bjoern[1][2]->SetLineStyle(2);
  grShade[2] = new TGraph(4);
  for(int i=0; i<4; i++){
    grShade[2]->SetPoint(i,Bjoern_xaxis_pp[i],Bjoern_Rhydro_pp[mchoice-1][i]);
    grShade[2]->SetPoint(4+i,Bjoern_xaxis_pp[4-i-1],Bjoern_Ri_pp[mchoice-1][4-i-1]);
  }
  grShade[2]->SetFillStyle(1000);
  grShade[2]->SetFillColor(kBlue-10);
  //
  grShade[0]->Draw("f same");
  grShade[1]->Draw("f same");
  grShade[2]->Draw("f same");
  Radii_Bjoern[0][0]->Draw("l same");
  Radii_Bjoern[0][1]->Draw("l same");
  Radii_Bjoern[0][2]->Draw("l same");
  
  grRadiiC2Sys_pp->Draw("|| p");
  grRadiiC2Sys_pPb->Draw("|| p");
  grRadiiC2Sys_PbPb->Draw("E p");
  RadiiC2PbPb->Draw("same");
  RadiiC2pPb->Draw("same");
  RadiiC2pp->Draw("same");

  legend9->AddEntry(Radii_Bjoern[0][2],"GLASMA pp R_{initial}","l");
  legend9->AddEntry(Radii_Bjoern[0][1],"GLASMA p-Pb R_{initial}","l");
  legend9->AddEntry(Radii_Bjoern[0][0],"GLASMA Pb-Pb R_{initial}","l");
  legend9->AddEntry(grShade[2],"GLASMA pp R_{hydro}","f");
  legend9->AddEntry(grShade[1],"GLASMA p-Pb R_{hydro}","f");
  legend9->AddEntry(grShade[0],"GLASMA Pb-Pb R_{hydro}","f");
  /*
  TF1 *fit1=new TF1("fit1","pol5",0,1000);
  fit1->SetLineColor(1);
  Radii_Bjoern[0][0]->Fit(fit1,"Q","",30,800);
  //fit1->Draw("same");
  //
  TF1 *fit2=new TF1("fit2","pol4",0,1000);
  Radii_Bjoern[0][1]->Fit(fit2,"Q","",4,70);
  //fit2->Draw("same");
  //
  TF1 *fit3=new TF1("fit3","pol4",0,1000);
  fit3->SetLineColor(1);
  Radii_Bjoern[0][2]->Fit(fit3,"Q","",4,27);
  //fit3->Draw("same");

  TH1D *BjoernRatio_PbPb = (TH1D*)RadiiC2PbPb->Clone();
  TH1D *BjoernRatio_pPb = (TH1D*)RadiiC2pPb->Clone();
  TH1D *BjoernRatio_pp = (TH1D*)RadiiC2pp->Clone();
  for(int point=0; point<20; point++){
    int bin = BjoernRatio_PbPb->GetXaxis()->FindBin(meanNchPbPb[point]);
    if(meanNchPbPb[point] > Bjoern_xaxis_PbPb[8]) {BjoernRatio_PbPb->SetBinContent(bin,0); continue;}
    if(BjoernRatio_PbPb->GetBinContent(bin) < 0.5 || BjoernRatio_PbPb->GetBinContent(bin) > 12) BjoernRatio_PbPb->SetBinContent(bin,0);
    else{
      //      double xx = 
      BjoernRatio_PbPb->SetBinContent(bin, BjoernRatio_PbPb->GetBinContent(bin) / fit1->Eval(meanNchPbPb[point]));
    }
  }
  for(int point=0; point<20; point++){
    int bin = BjoernRatio_pPb->GetXaxis()->FindBin(meanNchpPb[point]);
    if(meanNchpPb[point] > Bjoern_xaxis_pPb[5]) {BjoernRatio_pPb->SetBinContent(bin,0); continue;}
    if(BjoernRatio_pPb->GetBinContent(bin) < 0.5 || BjoernRatio_pPb->GetBinContent(bin) > 12) BjoernRatio_pPb->SetBinContent(bin,0);
    else{
      BjoernRatio_pPb->SetBinContent(bin, BjoernRatio_pPb->GetBinContent(bin) / fit2->Eval(meanNchpPb[point]));
    }
  }
  for(int point=0; point<20; point++){
    int bin = BjoernRatio_pp->GetXaxis()->FindBin(meanNchpp[point]);
    if(meanNchpp[point] > Bjoern_xaxis_pp[3]) {BjoernRatio_pp->SetBinContent(bin,0); continue;}
    if(BjoernRatio_pp->GetBinContent(bin) < 0.5 || BjoernRatio_pp->GetBinContent(bin) > 12) BjoernRatio_pp->SetBinContent(bin,0);
    else{
      BjoernRatio_pp->SetBinContent(bin, BjoernRatio_pp->GetBinContent(bin) / fit2->Eval(meanNchpp[point]));
    }
  }
  BjoernRatio_PbPb->SetMinimum(0.55); BjoernRatio_PbPb->SetMaximum(1.45); 
  BjoernRatio_PbPb->GetYaxis()->SetTitle("Radius Ratio (ALICE/GLASMA)");
  BjoernRatio_PbPb->Draw();
  BjoernRatio_pPb->Draw("same");
  BjoernRatio_pp->Draw("same");
  */
  
  /*legend8->AddEntry(Parameters_Bjoern[0][2],"pp R_{initial} (no hydro)","p");
  legend8->AddEntry(Parameters_Bjoern[0][1],"p-Pb R_{initial} (no hydro)","p");
  legend8->AddEntry(Parameters_Bjoern[0][0],"Pb-Pb R_{initial} (no hydro)","p");
  legend9->AddEntry(Parameters_Bjoern[1][2],"pp R_{max} (hydro)","p");
  legend9->AddEntry(Parameters_Bjoern[1][1],"p-Pb R_{max} (hydro)","p");
  legend9->AddEntry(Parameters_Bjoern[1][0],"Pb-Pb R_{max} (hydro)","p");
  */
  legend8->Draw("same");
  legend9->Draw("same");
  // Normalization plots
  // ct, ft, KT3, par
  //Parameters_C2[2][0][0][0]->Draw();
  



}
//____________________________________________________________________________________________________
void DrawALICELogo(Bool_t prel, Float_t x1, Float_t y1, Float_t x2, Float_t y2)
{
  // revision on July 24th or 25th 2012
  // correct for aspect ratio of figure plus aspect ratio of pad (coordinates are NDC!)
  x2 = x1 + (y2 - y1) * (466. / 523) * gPad->GetWh() * gPad->GetHNDC() / (gPad->GetWNDC() * gPad->GetWw());
  // Printf("%f %f %f %f", x1, x2, y1, y2);
  
  TPad *myPadLogo = new TPad("myPadLogo", "Pad for ALICE Logo", x1, y1, x2, y2);
  myPadLogo->SetLeftMargin(0);
  myPadLogo->SetTopMargin(0);
  myPadLogo->SetRightMargin(0);
  myPadLogo->SetBottomMargin(0);
  myPadLogo->Draw();
  myPadLogo->cd();
  TASImage *myAliceLogo = new TASImage((prel) ? "~/Pictures/2011-Nov-24-ALICE_PRELIMARY_logo_BLACK_small_usage_design.eps" : "~/Pictures/2011-Nov-24-ALICE_PERFORMANCE_logo_BLACK_small_usage_design.eps");
  myAliceLogo->Draw();
}
//____________________________________________________________________________________________________
TCanvas *make_canvas(const Char_t *name, const Char_t *title, Int_t n_x, Int_t n_y, Int_t share_axes, Int_t ww, Int_t wh){
  const Int_t width=350;
  const Int_t height=350;
  TCanvas *canvas;
 
  if (share_axes==0) {
    if (ww==0)
      ww=width*n_x;
    if (wh==0)
      wh=height*n_y;
    canvas=new TCanvas(name,title,10,0,ww,wh);
    canvas->SetTopMargin(0.01);
    canvas->SetRightMargin(0.01);
    canvas->SetLeftMargin(0.14); 
    canvas->SetBottomMargin(0.18); 
    
    canvas->Divide(n_x,n_y,0,0);
  }
  else {
    Float_t pix_width=(1-gStyle->GetPadLeftMargin()-gStyle->GetPadRightMargin())*width;
    Float_t pix_height=(1-gStyle->GetPadTopMargin()-gStyle->GetPadBottomMargin())*height;
    if (ww==0)
      ww=width+(n_x-1)*pix_width;
    if (wh==0)
      wh=height+(n_y-1)*pix_height;

    canvas=new TCanvas(name,title,ww,wh);
    canvas->SetTopMargin(0); canvas->SetBottomMargin(0); 
    canvas->SetLeftMargin(0); canvas->SetRightMargin(0); 
    Float_t tot_width;
    if (n_x>1) 
      tot_width=(n_x-2)+1./(1-gStyle->GetPadLeftMargin())
	+1./(1-gStyle->GetPadRightMargin());
    else
      tot_width=1./(1-gStyle->GetPadLeftMargin()-gStyle->GetPadRightMargin());
    Float_t tot_height;
    if (n_y>1) 
      tot_height=(n_y-2)+1./(1-gStyle->GetPadTopMargin())
	+1./(1-gStyle->GetPadBottomMargin());
    else
      tot_height=1./(1-gStyle->GetPadTopMargin()-gStyle->GetPadBottomMargin());

    //Int_t idx=n_x*n_y;
    
    for (Int_t j=0; j<n_y; j++) {
      for (Int_t i=0; i<n_x; i++) {
	//for (Int_t j=n_y-1; j>=0; j--) {
	//for (Int_t i=n_x-1; i>=0; i--) {
	Char_t tmp_str[256];
	Char_t p_title[256];
	Int_t idx=n_x*j+i+1;
	sprintf(tmp_str,"%s_%d",canvas->GetName(),idx);
	sprintf(p_title,"Pad %d",idx);
	Float_t x1=0,y1=0;
	Float_t x2=1,y2=1;
	if (n_x>1) {
	  if (i==0) 
	    x2=1./(1-gStyle->GetPadLeftMargin())/tot_width;
	  else {
	    x1=(1./(1-gStyle->GetPadLeftMargin())+i-1)/tot_width;
	    if (i<n_x-1)
	      x2=(1./(1-gStyle->GetPadLeftMargin())+i)/tot_width;
	  }
	}
	if (n_y>1) {
	  if (j==0) 
	    y1=1-1./(1-gStyle->GetPadTopMargin())/tot_height;
	  else {
	    y2=1-(1./(1-gStyle->GetPadTopMargin())+j-1)/tot_height;
	    if (j<n_y-1)
	      y1=1-(1./(1-gStyle->GetPadTopMargin())+j)/tot_height;
	  }
	}
	//cout << "x1 " << x1 << ", x2 " << x2 << endl;
	TPad *pad=new TPad(tmp_str,title,x1,y1,x2,y2);
	//pad->SetFillColor(idx+1);
	if (i>0)
	  pad->SetLeftMargin(0.001);
	if (i<n_x-1)
	  pad->SetRightMargin(0.001);
	if (j>0)
	  pad->SetTopMargin(0.001);
	if (j<n_y-1)
	  pad->SetBottomMargin(0.001);


	pad->SetNumber(idx);
	//pad->SetNumber(n_x*j+i+1);
	pad->Draw();
	//idx--;
	//idx++;
	//pad->SetP
      }
    }
  }

  return canvas;
}
 Plot_plotsTPR.C:1
 Plot_plotsTPR.C:2
 Plot_plotsTPR.C:3
 Plot_plotsTPR.C:4
 Plot_plotsTPR.C:5
 Plot_plotsTPR.C:6
 Plot_plotsTPR.C:7
 Plot_plotsTPR.C:8
 Plot_plotsTPR.C:9
 Plot_plotsTPR.C:10
 Plot_plotsTPR.C:11
 Plot_plotsTPR.C:12
 Plot_plotsTPR.C:13
 Plot_plotsTPR.C:14
 Plot_plotsTPR.C:15
 Plot_plotsTPR.C:16
 Plot_plotsTPR.C:17
 Plot_plotsTPR.C:18
 Plot_plotsTPR.C:19
 Plot_plotsTPR.C:20
 Plot_plotsTPR.C:21
 Plot_plotsTPR.C:22
 Plot_plotsTPR.C:23
 Plot_plotsTPR.C:24
 Plot_plotsTPR.C:25
 Plot_plotsTPR.C:26
 Plot_plotsTPR.C:27
 Plot_plotsTPR.C:28
 Plot_plotsTPR.C:29
 Plot_plotsTPR.C:30
 Plot_plotsTPR.C:31
 Plot_plotsTPR.C:32
 Plot_plotsTPR.C:33
 Plot_plotsTPR.C:34
 Plot_plotsTPR.C:35
 Plot_plotsTPR.C:36
 Plot_plotsTPR.C:37
 Plot_plotsTPR.C:38
 Plot_plotsTPR.C:39
 Plot_plotsTPR.C:40
 Plot_plotsTPR.C:41
 Plot_plotsTPR.C:42
 Plot_plotsTPR.C:43
 Plot_plotsTPR.C:44
 Plot_plotsTPR.C:45
 Plot_plotsTPR.C:46
 Plot_plotsTPR.C:47
 Plot_plotsTPR.C:48
 Plot_plotsTPR.C:49
 Plot_plotsTPR.C:50
 Plot_plotsTPR.C:51
 Plot_plotsTPR.C:52
 Plot_plotsTPR.C:53
 Plot_plotsTPR.C:54
 Plot_plotsTPR.C:55
 Plot_plotsTPR.C:56
 Plot_plotsTPR.C:57
 Plot_plotsTPR.C:58
 Plot_plotsTPR.C:59
 Plot_plotsTPR.C:60
 Plot_plotsTPR.C:61
 Plot_plotsTPR.C:62
 Plot_plotsTPR.C:63
 Plot_plotsTPR.C:64
 Plot_plotsTPR.C:65
 Plot_plotsTPR.C:66
 Plot_plotsTPR.C:67
 Plot_plotsTPR.C:68
 Plot_plotsTPR.C:69
 Plot_plotsTPR.C:70
 Plot_plotsTPR.C:71
 Plot_plotsTPR.C:72
 Plot_plotsTPR.C:73
 Plot_plotsTPR.C:74
 Plot_plotsTPR.C:75
 Plot_plotsTPR.C:76
 Plot_plotsTPR.C:77
 Plot_plotsTPR.C:78
 Plot_plotsTPR.C:79
 Plot_plotsTPR.C:80
 Plot_plotsTPR.C:81
 Plot_plotsTPR.C:82
 Plot_plotsTPR.C:83
 Plot_plotsTPR.C:84
 Plot_plotsTPR.C:85
 Plot_plotsTPR.C:86
 Plot_plotsTPR.C:87
 Plot_plotsTPR.C:88
 Plot_plotsTPR.C:89
 Plot_plotsTPR.C:90
 Plot_plotsTPR.C:91
 Plot_plotsTPR.C:92
 Plot_plotsTPR.C:93
 Plot_plotsTPR.C:94
 Plot_plotsTPR.C:95
 Plot_plotsTPR.C:96
 Plot_plotsTPR.C:97
 Plot_plotsTPR.C:98
 Plot_plotsTPR.C:99
 Plot_plotsTPR.C:100
 Plot_plotsTPR.C:101
 Plot_plotsTPR.C:102
 Plot_plotsTPR.C:103
 Plot_plotsTPR.C:104
 Plot_plotsTPR.C:105
 Plot_plotsTPR.C:106
 Plot_plotsTPR.C:107
 Plot_plotsTPR.C:108
 Plot_plotsTPR.C:109
 Plot_plotsTPR.C:110
 Plot_plotsTPR.C:111
 Plot_plotsTPR.C:112
 Plot_plotsTPR.C:113
 Plot_plotsTPR.C:114
 Plot_plotsTPR.C:115
 Plot_plotsTPR.C:116
 Plot_plotsTPR.C:117
 Plot_plotsTPR.C:118
 Plot_plotsTPR.C:119
 Plot_plotsTPR.C:120
 Plot_plotsTPR.C:121
 Plot_plotsTPR.C:122
 Plot_plotsTPR.C:123
 Plot_plotsTPR.C:124
 Plot_plotsTPR.C:125
 Plot_plotsTPR.C:126
 Plot_plotsTPR.C:127
 Plot_plotsTPR.C:128
 Plot_plotsTPR.C:129
 Plot_plotsTPR.C:130
 Plot_plotsTPR.C:131
 Plot_plotsTPR.C:132
 Plot_plotsTPR.C:133
 Plot_plotsTPR.C:134
 Plot_plotsTPR.C:135
 Plot_plotsTPR.C:136
 Plot_plotsTPR.C:137
 Plot_plotsTPR.C:138
 Plot_plotsTPR.C:139
 Plot_plotsTPR.C:140
 Plot_plotsTPR.C:141
 Plot_plotsTPR.C:142
 Plot_plotsTPR.C:143
 Plot_plotsTPR.C:144
 Plot_plotsTPR.C:145
 Plot_plotsTPR.C:146
 Plot_plotsTPR.C:147
 Plot_plotsTPR.C:148
 Plot_plotsTPR.C:149
 Plot_plotsTPR.C:150
 Plot_plotsTPR.C:151
 Plot_plotsTPR.C:152
 Plot_plotsTPR.C:153
 Plot_plotsTPR.C:154
 Plot_plotsTPR.C:155
 Plot_plotsTPR.C:156
 Plot_plotsTPR.C:157
 Plot_plotsTPR.C:158
 Plot_plotsTPR.C:159
 Plot_plotsTPR.C:160
 Plot_plotsTPR.C:161
 Plot_plotsTPR.C:162
 Plot_plotsTPR.C:163
 Plot_plotsTPR.C:164
 Plot_plotsTPR.C:165
 Plot_plotsTPR.C:166
 Plot_plotsTPR.C:167
 Plot_plotsTPR.C:168
 Plot_plotsTPR.C:169
 Plot_plotsTPR.C:170
 Plot_plotsTPR.C:171
 Plot_plotsTPR.C:172
 Plot_plotsTPR.C:173
 Plot_plotsTPR.C:174
 Plot_plotsTPR.C:175
 Plot_plotsTPR.C:176
 Plot_plotsTPR.C:177
 Plot_plotsTPR.C:178
 Plot_plotsTPR.C:179
 Plot_plotsTPR.C:180
 Plot_plotsTPR.C:181
 Plot_plotsTPR.C:182
 Plot_plotsTPR.C:183
 Plot_plotsTPR.C:184
 Plot_plotsTPR.C:185
 Plot_plotsTPR.C:186
 Plot_plotsTPR.C:187
 Plot_plotsTPR.C:188
 Plot_plotsTPR.C:189
 Plot_plotsTPR.C:190
 Plot_plotsTPR.C:191
 Plot_plotsTPR.C:192
 Plot_plotsTPR.C:193
 Plot_plotsTPR.C:194
 Plot_plotsTPR.C:195
 Plot_plotsTPR.C:196
 Plot_plotsTPR.C:197
 Plot_plotsTPR.C:198
 Plot_plotsTPR.C:199
 Plot_plotsTPR.C:200
 Plot_plotsTPR.C:201
 Plot_plotsTPR.C:202
 Plot_plotsTPR.C:203
 Plot_plotsTPR.C:204
 Plot_plotsTPR.C:205
 Plot_plotsTPR.C:206
 Plot_plotsTPR.C:207
 Plot_plotsTPR.C:208
 Plot_plotsTPR.C:209
 Plot_plotsTPR.C:210
 Plot_plotsTPR.C:211
 Plot_plotsTPR.C:212
 Plot_plotsTPR.C:213
 Plot_plotsTPR.C:214
 Plot_plotsTPR.C:215
 Plot_plotsTPR.C:216
 Plot_plotsTPR.C:217
 Plot_plotsTPR.C:218
 Plot_plotsTPR.C:219
 Plot_plotsTPR.C:220
 Plot_plotsTPR.C:221
 Plot_plotsTPR.C:222
 Plot_plotsTPR.C:223
 Plot_plotsTPR.C:224
 Plot_plotsTPR.C:225
 Plot_plotsTPR.C:226
 Plot_plotsTPR.C:227
 Plot_plotsTPR.C:228
 Plot_plotsTPR.C:229
 Plot_plotsTPR.C:230
 Plot_plotsTPR.C:231
 Plot_plotsTPR.C:232
 Plot_plotsTPR.C:233
 Plot_plotsTPR.C:234
 Plot_plotsTPR.C:235
 Plot_plotsTPR.C:236
 Plot_plotsTPR.C:237
 Plot_plotsTPR.C:238
 Plot_plotsTPR.C:239
 Plot_plotsTPR.C:240
 Plot_plotsTPR.C:241
 Plot_plotsTPR.C:242
 Plot_plotsTPR.C:243
 Plot_plotsTPR.C:244
 Plot_plotsTPR.C:245
 Plot_plotsTPR.C:246
 Plot_plotsTPR.C:247
 Plot_plotsTPR.C:248
 Plot_plotsTPR.C:249
 Plot_plotsTPR.C:250
 Plot_plotsTPR.C:251
 Plot_plotsTPR.C:252
 Plot_plotsTPR.C:253
 Plot_plotsTPR.C:254
 Plot_plotsTPR.C:255
 Plot_plotsTPR.C:256
 Plot_plotsTPR.C:257
 Plot_plotsTPR.C:258
 Plot_plotsTPR.C:259
 Plot_plotsTPR.C:260
 Plot_plotsTPR.C:261
 Plot_plotsTPR.C:262
 Plot_plotsTPR.C:263
 Plot_plotsTPR.C:264
 Plot_plotsTPR.C:265
 Plot_plotsTPR.C:266
 Plot_plotsTPR.C:267
 Plot_plotsTPR.C:268
 Plot_plotsTPR.C:269
 Plot_plotsTPR.C:270
 Plot_plotsTPR.C:271
 Plot_plotsTPR.C:272
 Plot_plotsTPR.C:273
 Plot_plotsTPR.C:274
 Plot_plotsTPR.C:275
 Plot_plotsTPR.C:276
 Plot_plotsTPR.C:277
 Plot_plotsTPR.C:278
 Plot_plotsTPR.C:279
 Plot_plotsTPR.C:280
 Plot_plotsTPR.C:281
 Plot_plotsTPR.C:282
 Plot_plotsTPR.C:283
 Plot_plotsTPR.C:284
 Plot_plotsTPR.C:285
 Plot_plotsTPR.C:286
 Plot_plotsTPR.C:287
 Plot_plotsTPR.C:288
 Plot_plotsTPR.C:289
 Plot_plotsTPR.C:290
 Plot_plotsTPR.C:291
 Plot_plotsTPR.C:292
 Plot_plotsTPR.C:293
 Plot_plotsTPR.C:294
 Plot_plotsTPR.C:295
 Plot_plotsTPR.C:296
 Plot_plotsTPR.C:297
 Plot_plotsTPR.C:298
 Plot_plotsTPR.C:299
 Plot_plotsTPR.C:300
 Plot_plotsTPR.C:301
 Plot_plotsTPR.C:302
 Plot_plotsTPR.C:303
 Plot_plotsTPR.C:304
 Plot_plotsTPR.C:305
 Plot_plotsTPR.C:306
 Plot_plotsTPR.C:307
 Plot_plotsTPR.C:308
 Plot_plotsTPR.C:309
 Plot_plotsTPR.C:310
 Plot_plotsTPR.C:311
 Plot_plotsTPR.C:312
 Plot_plotsTPR.C:313
 Plot_plotsTPR.C:314
 Plot_plotsTPR.C:315
 Plot_plotsTPR.C:316
 Plot_plotsTPR.C:317
 Plot_plotsTPR.C:318
 Plot_plotsTPR.C:319
 Plot_plotsTPR.C:320
 Plot_plotsTPR.C:321
 Plot_plotsTPR.C:322
 Plot_plotsTPR.C:323
 Plot_plotsTPR.C:324
 Plot_plotsTPR.C:325
 Plot_plotsTPR.C:326
 Plot_plotsTPR.C:327
 Plot_plotsTPR.C:328
 Plot_plotsTPR.C:329
 Plot_plotsTPR.C:330
 Plot_plotsTPR.C:331
 Plot_plotsTPR.C:332
 Plot_plotsTPR.C:333
 Plot_plotsTPR.C:334
 Plot_plotsTPR.C:335
 Plot_plotsTPR.C:336
 Plot_plotsTPR.C:337
 Plot_plotsTPR.C:338
 Plot_plotsTPR.C:339
 Plot_plotsTPR.C:340
 Plot_plotsTPR.C:341
 Plot_plotsTPR.C:342
 Plot_plotsTPR.C:343
 Plot_plotsTPR.C:344
 Plot_plotsTPR.C:345
 Plot_plotsTPR.C:346
 Plot_plotsTPR.C:347
 Plot_plotsTPR.C:348
 Plot_plotsTPR.C:349
 Plot_plotsTPR.C:350
 Plot_plotsTPR.C:351
 Plot_plotsTPR.C:352
 Plot_plotsTPR.C:353
 Plot_plotsTPR.C:354
 Plot_plotsTPR.C:355
 Plot_plotsTPR.C:356
 Plot_plotsTPR.C:357
 Plot_plotsTPR.C:358
 Plot_plotsTPR.C:359
 Plot_plotsTPR.C:360
 Plot_plotsTPR.C:361
 Plot_plotsTPR.C:362
 Plot_plotsTPR.C:363
 Plot_plotsTPR.C:364
 Plot_plotsTPR.C:365
 Plot_plotsTPR.C:366
 Plot_plotsTPR.C:367
 Plot_plotsTPR.C:368
 Plot_plotsTPR.C:369
 Plot_plotsTPR.C:370
 Plot_plotsTPR.C:371
 Plot_plotsTPR.C:372
 Plot_plotsTPR.C:373
 Plot_plotsTPR.C:374
 Plot_plotsTPR.C:375
 Plot_plotsTPR.C:376
 Plot_plotsTPR.C:377
 Plot_plotsTPR.C:378
 Plot_plotsTPR.C:379
 Plot_plotsTPR.C:380
 Plot_plotsTPR.C:381
 Plot_plotsTPR.C:382
 Plot_plotsTPR.C:383
 Plot_plotsTPR.C:384
 Plot_plotsTPR.C:385
 Plot_plotsTPR.C:386
 Plot_plotsTPR.C:387
 Plot_plotsTPR.C:388
 Plot_plotsTPR.C:389
 Plot_plotsTPR.C:390
 Plot_plotsTPR.C:391
 Plot_plotsTPR.C:392
 Plot_plotsTPR.C:393
 Plot_plotsTPR.C:394
 Plot_plotsTPR.C:395
 Plot_plotsTPR.C:396
 Plot_plotsTPR.C:397
 Plot_plotsTPR.C:398
 Plot_plotsTPR.C:399
 Plot_plotsTPR.C:400
 Plot_plotsTPR.C:401
 Plot_plotsTPR.C:402
 Plot_plotsTPR.C:403
 Plot_plotsTPR.C:404
 Plot_plotsTPR.C:405
 Plot_plotsTPR.C:406
 Plot_plotsTPR.C:407
 Plot_plotsTPR.C:408
 Plot_plotsTPR.C:409
 Plot_plotsTPR.C:410
 Plot_plotsTPR.C:411
 Plot_plotsTPR.C:412
 Plot_plotsTPR.C:413
 Plot_plotsTPR.C:414
 Plot_plotsTPR.C:415
 Plot_plotsTPR.C:416
 Plot_plotsTPR.C:417
 Plot_plotsTPR.C:418
 Plot_plotsTPR.C:419
 Plot_plotsTPR.C:420
 Plot_plotsTPR.C:421
 Plot_plotsTPR.C:422
 Plot_plotsTPR.C:423
 Plot_plotsTPR.C:424
 Plot_plotsTPR.C:425
 Plot_plotsTPR.C:426
 Plot_plotsTPR.C:427
 Plot_plotsTPR.C:428
 Plot_plotsTPR.C:429
 Plot_plotsTPR.C:430
 Plot_plotsTPR.C:431
 Plot_plotsTPR.C:432
 Plot_plotsTPR.C:433
 Plot_plotsTPR.C:434
 Plot_plotsTPR.C:435
 Plot_plotsTPR.C:436
 Plot_plotsTPR.C:437
 Plot_plotsTPR.C:438
 Plot_plotsTPR.C:439
 Plot_plotsTPR.C:440
 Plot_plotsTPR.C:441
 Plot_plotsTPR.C:442
 Plot_plotsTPR.C:443
 Plot_plotsTPR.C:444
 Plot_plotsTPR.C:445
 Plot_plotsTPR.C:446
 Plot_plotsTPR.C:447
 Plot_plotsTPR.C:448
 Plot_plotsTPR.C:449
 Plot_plotsTPR.C:450
 Plot_plotsTPR.C:451
 Plot_plotsTPR.C:452
 Plot_plotsTPR.C:453
 Plot_plotsTPR.C:454
 Plot_plotsTPR.C:455
 Plot_plotsTPR.C:456
 Plot_plotsTPR.C:457
 Plot_plotsTPR.C:458
 Plot_plotsTPR.C:459
 Plot_plotsTPR.C:460
 Plot_plotsTPR.C:461
 Plot_plotsTPR.C:462
 Plot_plotsTPR.C:463
 Plot_plotsTPR.C:464
 Plot_plotsTPR.C:465
 Plot_plotsTPR.C:466
 Plot_plotsTPR.C:467
 Plot_plotsTPR.C:468
 Plot_plotsTPR.C:469
 Plot_plotsTPR.C:470
 Plot_plotsTPR.C:471
 Plot_plotsTPR.C:472
 Plot_plotsTPR.C:473
 Plot_plotsTPR.C:474
 Plot_plotsTPR.C:475
 Plot_plotsTPR.C:476
 Plot_plotsTPR.C:477
 Plot_plotsTPR.C:478
 Plot_plotsTPR.C:479
 Plot_plotsTPR.C:480
 Plot_plotsTPR.C:481
 Plot_plotsTPR.C:482
 Plot_plotsTPR.C:483
 Plot_plotsTPR.C:484
 Plot_plotsTPR.C:485
 Plot_plotsTPR.C:486
 Plot_plotsTPR.C:487
 Plot_plotsTPR.C:488
 Plot_plotsTPR.C:489
 Plot_plotsTPR.C:490
 Plot_plotsTPR.C:491
 Plot_plotsTPR.C:492
 Plot_plotsTPR.C:493
 Plot_plotsTPR.C:494
 Plot_plotsTPR.C:495
 Plot_plotsTPR.C:496
 Plot_plotsTPR.C:497
 Plot_plotsTPR.C:498
 Plot_plotsTPR.C:499
 Plot_plotsTPR.C:500
 Plot_plotsTPR.C:501
 Plot_plotsTPR.C:502
 Plot_plotsTPR.C:503
 Plot_plotsTPR.C:504
 Plot_plotsTPR.C:505
 Plot_plotsTPR.C:506
 Plot_plotsTPR.C:507
 Plot_plotsTPR.C:508
 Plot_plotsTPR.C:509
 Plot_plotsTPR.C:510
 Plot_plotsTPR.C:511
 Plot_plotsTPR.C:512
 Plot_plotsTPR.C:513
 Plot_plotsTPR.C:514
 Plot_plotsTPR.C:515
 Plot_plotsTPR.C:516
 Plot_plotsTPR.C:517
 Plot_plotsTPR.C:518
 Plot_plotsTPR.C:519
 Plot_plotsTPR.C:520
 Plot_plotsTPR.C:521
 Plot_plotsTPR.C:522
 Plot_plotsTPR.C:523
 Plot_plotsTPR.C:524
 Plot_plotsTPR.C:525
 Plot_plotsTPR.C:526
 Plot_plotsTPR.C:527
 Plot_plotsTPR.C:528
 Plot_plotsTPR.C:529
 Plot_plotsTPR.C:530
 Plot_plotsTPR.C:531
 Plot_plotsTPR.C:532
 Plot_plotsTPR.C:533
 Plot_plotsTPR.C:534
 Plot_plotsTPR.C:535
 Plot_plotsTPR.C:536
 Plot_plotsTPR.C:537
 Plot_plotsTPR.C:538
 Plot_plotsTPR.C:539
 Plot_plotsTPR.C:540
 Plot_plotsTPR.C:541
 Plot_plotsTPR.C:542
 Plot_plotsTPR.C:543
 Plot_plotsTPR.C:544
 Plot_plotsTPR.C:545
 Plot_plotsTPR.C:546
 Plot_plotsTPR.C:547
 Plot_plotsTPR.C:548
 Plot_plotsTPR.C:549
 Plot_plotsTPR.C:550
 Plot_plotsTPR.C:551
 Plot_plotsTPR.C:552
 Plot_plotsTPR.C:553
 Plot_plotsTPR.C:554
 Plot_plotsTPR.C:555
 Plot_plotsTPR.C:556
 Plot_plotsTPR.C:557
 Plot_plotsTPR.C:558
 Plot_plotsTPR.C:559
 Plot_plotsTPR.C:560
 Plot_plotsTPR.C:561
 Plot_plotsTPR.C:562
 Plot_plotsTPR.C:563
 Plot_plotsTPR.C:564
 Plot_plotsTPR.C:565
 Plot_plotsTPR.C:566
 Plot_plotsTPR.C:567
 Plot_plotsTPR.C:568
 Plot_plotsTPR.C:569
 Plot_plotsTPR.C:570
 Plot_plotsTPR.C:571
 Plot_plotsTPR.C:572
 Plot_plotsTPR.C:573
 Plot_plotsTPR.C:574
 Plot_plotsTPR.C:575
 Plot_plotsTPR.C:576
 Plot_plotsTPR.C:577
 Plot_plotsTPR.C:578
 Plot_plotsTPR.C:579
 Plot_plotsTPR.C:580
 Plot_plotsTPR.C:581
 Plot_plotsTPR.C:582
 Plot_plotsTPR.C:583
 Plot_plotsTPR.C:584
 Plot_plotsTPR.C:585
 Plot_plotsTPR.C:586
 Plot_plotsTPR.C:587
 Plot_plotsTPR.C:588
 Plot_plotsTPR.C:589
 Plot_plotsTPR.C:590
 Plot_plotsTPR.C:591
 Plot_plotsTPR.C:592
 Plot_plotsTPR.C:593
 Plot_plotsTPR.C:594
 Plot_plotsTPR.C:595
 Plot_plotsTPR.C:596
 Plot_plotsTPR.C:597
 Plot_plotsTPR.C:598
 Plot_plotsTPR.C:599
 Plot_plotsTPR.C:600
 Plot_plotsTPR.C:601
 Plot_plotsTPR.C:602
 Plot_plotsTPR.C:603
 Plot_plotsTPR.C:604
 Plot_plotsTPR.C:605
 Plot_plotsTPR.C:606
 Plot_plotsTPR.C:607
 Plot_plotsTPR.C:608
 Plot_plotsTPR.C:609
 Plot_plotsTPR.C:610
 Plot_plotsTPR.C:611
 Plot_plotsTPR.C:612
 Plot_plotsTPR.C:613
 Plot_plotsTPR.C:614
 Plot_plotsTPR.C:615
 Plot_plotsTPR.C:616
 Plot_plotsTPR.C:617
 Plot_plotsTPR.C:618
 Plot_plotsTPR.C:619
 Plot_plotsTPR.C:620
 Plot_plotsTPR.C:621
 Plot_plotsTPR.C:622
 Plot_plotsTPR.C:623
 Plot_plotsTPR.C:624
 Plot_plotsTPR.C:625
 Plot_plotsTPR.C:626
 Plot_plotsTPR.C:627
 Plot_plotsTPR.C:628
 Plot_plotsTPR.C:629
 Plot_plotsTPR.C:630
 Plot_plotsTPR.C:631
 Plot_plotsTPR.C:632
 Plot_plotsTPR.C:633
 Plot_plotsTPR.C:634
 Plot_plotsTPR.C:635
 Plot_plotsTPR.C:636
 Plot_plotsTPR.C:637
 Plot_plotsTPR.C:638
 Plot_plotsTPR.C:639
 Plot_plotsTPR.C:640
 Plot_plotsTPR.C:641
 Plot_plotsTPR.C:642
 Plot_plotsTPR.C:643
 Plot_plotsTPR.C:644
 Plot_plotsTPR.C:645
 Plot_plotsTPR.C:646
 Plot_plotsTPR.C:647
 Plot_plotsTPR.C:648
 Plot_plotsTPR.C:649
 Plot_plotsTPR.C:650
 Plot_plotsTPR.C:651
 Plot_plotsTPR.C:652
 Plot_plotsTPR.C:653
 Plot_plotsTPR.C:654
 Plot_plotsTPR.C:655
 Plot_plotsTPR.C:656
 Plot_plotsTPR.C:657
 Plot_plotsTPR.C:658
 Plot_plotsTPR.C:659
 Plot_plotsTPR.C:660
 Plot_plotsTPR.C:661
 Plot_plotsTPR.C:662
 Plot_plotsTPR.C:663
 Plot_plotsTPR.C:664
 Plot_plotsTPR.C:665
 Plot_plotsTPR.C:666
 Plot_plotsTPR.C:667
 Plot_plotsTPR.C:668
 Plot_plotsTPR.C:669
 Plot_plotsTPR.C:670
 Plot_plotsTPR.C:671
 Plot_plotsTPR.C:672
 Plot_plotsTPR.C:673
 Plot_plotsTPR.C:674
 Plot_plotsTPR.C:675
 Plot_plotsTPR.C:676
 Plot_plotsTPR.C:677
 Plot_plotsTPR.C:678
 Plot_plotsTPR.C:679
 Plot_plotsTPR.C:680
 Plot_plotsTPR.C:681
 Plot_plotsTPR.C:682
 Plot_plotsTPR.C:683
 Plot_plotsTPR.C:684
 Plot_plotsTPR.C:685
 Plot_plotsTPR.C:686
 Plot_plotsTPR.C:687
 Plot_plotsTPR.C:688
 Plot_plotsTPR.C:689
 Plot_plotsTPR.C:690
 Plot_plotsTPR.C:691
 Plot_plotsTPR.C:692
 Plot_plotsTPR.C:693
 Plot_plotsTPR.C:694
 Plot_plotsTPR.C:695
 Plot_plotsTPR.C:696
 Plot_plotsTPR.C:697
 Plot_plotsTPR.C:698
 Plot_plotsTPR.C:699
 Plot_plotsTPR.C:700
 Plot_plotsTPR.C:701
 Plot_plotsTPR.C:702
 Plot_plotsTPR.C:703
 Plot_plotsTPR.C:704
 Plot_plotsTPR.C:705
 Plot_plotsTPR.C:706
 Plot_plotsTPR.C:707
 Plot_plotsTPR.C:708
 Plot_plotsTPR.C:709
 Plot_plotsTPR.C:710
 Plot_plotsTPR.C:711
 Plot_plotsTPR.C:712
 Plot_plotsTPR.C:713
 Plot_plotsTPR.C:714
 Plot_plotsTPR.C:715
 Plot_plotsTPR.C:716
 Plot_plotsTPR.C:717
 Plot_plotsTPR.C:718
 Plot_plotsTPR.C:719
 Plot_plotsTPR.C:720
 Plot_plotsTPR.C:721
 Plot_plotsTPR.C:722
 Plot_plotsTPR.C:723
 Plot_plotsTPR.C:724
 Plot_plotsTPR.C:725
 Plot_plotsTPR.C:726
 Plot_plotsTPR.C:727
 Plot_plotsTPR.C:728
 Plot_plotsTPR.C:729
 Plot_plotsTPR.C:730
 Plot_plotsTPR.C:731
 Plot_plotsTPR.C:732
 Plot_plotsTPR.C:733
 Plot_plotsTPR.C:734
 Plot_plotsTPR.C:735
 Plot_plotsTPR.C:736
 Plot_plotsTPR.C:737
 Plot_plotsTPR.C:738
 Plot_plotsTPR.C:739
 Plot_plotsTPR.C:740
 Plot_plotsTPR.C:741
 Plot_plotsTPR.C:742
 Plot_plotsTPR.C:743
 Plot_plotsTPR.C:744
 Plot_plotsTPR.C:745
 Plot_plotsTPR.C:746
 Plot_plotsTPR.C:747
 Plot_plotsTPR.C:748
 Plot_plotsTPR.C:749
 Plot_plotsTPR.C:750
 Plot_plotsTPR.C:751
 Plot_plotsTPR.C:752
 Plot_plotsTPR.C:753
 Plot_plotsTPR.C:754
 Plot_plotsTPR.C:755
 Plot_plotsTPR.C:756
 Plot_plotsTPR.C:757
 Plot_plotsTPR.C:758
 Plot_plotsTPR.C:759
 Plot_plotsTPR.C:760
 Plot_plotsTPR.C:761
 Plot_plotsTPR.C:762
 Plot_plotsTPR.C:763
 Plot_plotsTPR.C:764
 Plot_plotsTPR.C:765
 Plot_plotsTPR.C:766
 Plot_plotsTPR.C:767
 Plot_plotsTPR.C:768
 Plot_plotsTPR.C:769
 Plot_plotsTPR.C:770
 Plot_plotsTPR.C:771
 Plot_plotsTPR.C:772
 Plot_plotsTPR.C:773
 Plot_plotsTPR.C:774
 Plot_plotsTPR.C:775
 Plot_plotsTPR.C:776
 Plot_plotsTPR.C:777
 Plot_plotsTPR.C:778
 Plot_plotsTPR.C:779
 Plot_plotsTPR.C:780
 Plot_plotsTPR.C:781
 Plot_plotsTPR.C:782
 Plot_plotsTPR.C:783
 Plot_plotsTPR.C:784
 Plot_plotsTPR.C:785
 Plot_plotsTPR.C:786
 Plot_plotsTPR.C:787
 Plot_plotsTPR.C:788
 Plot_plotsTPR.C:789
 Plot_plotsTPR.C:790
 Plot_plotsTPR.C:791
 Plot_plotsTPR.C:792
 Plot_plotsTPR.C:793
 Plot_plotsTPR.C:794
 Plot_plotsTPR.C:795
 Plot_plotsTPR.C:796
 Plot_plotsTPR.C:797
 Plot_plotsTPR.C:798
 Plot_plotsTPR.C:799
 Plot_plotsTPR.C:800
 Plot_plotsTPR.C:801
 Plot_plotsTPR.C:802
 Plot_plotsTPR.C:803
 Plot_plotsTPR.C:804
 Plot_plotsTPR.C:805
 Plot_plotsTPR.C:806
 Plot_plotsTPR.C:807
 Plot_plotsTPR.C:808
 Plot_plotsTPR.C:809
 Plot_plotsTPR.C:810
 Plot_plotsTPR.C:811
 Plot_plotsTPR.C:812
 Plot_plotsTPR.C:813
 Plot_plotsTPR.C:814
 Plot_plotsTPR.C:815
 Plot_plotsTPR.C:816
 Plot_plotsTPR.C:817
 Plot_plotsTPR.C:818
 Plot_plotsTPR.C:819
 Plot_plotsTPR.C:820
 Plot_plotsTPR.C:821
 Plot_plotsTPR.C:822
 Plot_plotsTPR.C:823
 Plot_plotsTPR.C:824
 Plot_plotsTPR.C:825
 Plot_plotsTPR.C:826
 Plot_plotsTPR.C:827
 Plot_plotsTPR.C:828
 Plot_plotsTPR.C:829
 Plot_plotsTPR.C:830
 Plot_plotsTPR.C:831
 Plot_plotsTPR.C:832
 Plot_plotsTPR.C:833
 Plot_plotsTPR.C:834
 Plot_plotsTPR.C:835
 Plot_plotsTPR.C:836
 Plot_plotsTPR.C:837
 Plot_plotsTPR.C:838
 Plot_plotsTPR.C:839
 Plot_plotsTPR.C:840
 Plot_plotsTPR.C:841
 Plot_plotsTPR.C:842
 Plot_plotsTPR.C:843
 Plot_plotsTPR.C:844
 Plot_plotsTPR.C:845
 Plot_plotsTPR.C:846
 Plot_plotsTPR.C:847
 Plot_plotsTPR.C:848
 Plot_plotsTPR.C:849
 Plot_plotsTPR.C:850
 Plot_plotsTPR.C:851
 Plot_plotsTPR.C:852
 Plot_plotsTPR.C:853
 Plot_plotsTPR.C:854
 Plot_plotsTPR.C:855
 Plot_plotsTPR.C:856
 Plot_plotsTPR.C:857
 Plot_plotsTPR.C:858
 Plot_plotsTPR.C:859
 Plot_plotsTPR.C:860
 Plot_plotsTPR.C:861
 Plot_plotsTPR.C:862
 Plot_plotsTPR.C:863
 Plot_plotsTPR.C:864
 Plot_plotsTPR.C:865
 Plot_plotsTPR.C:866
 Plot_plotsTPR.C:867
 Plot_plotsTPR.C:868
 Plot_plotsTPR.C:869
 Plot_plotsTPR.C:870
 Plot_plotsTPR.C:871
 Plot_plotsTPR.C:872
 Plot_plotsTPR.C:873
 Plot_plotsTPR.C:874
 Plot_plotsTPR.C:875
 Plot_plotsTPR.C:876
 Plot_plotsTPR.C:877
 Plot_plotsTPR.C:878
 Plot_plotsTPR.C:879
 Plot_plotsTPR.C:880
 Plot_plotsTPR.C:881
 Plot_plotsTPR.C:882
 Plot_plotsTPR.C:883
 Plot_plotsTPR.C:884
 Plot_plotsTPR.C:885
 Plot_plotsTPR.C:886
 Plot_plotsTPR.C:887
 Plot_plotsTPR.C:888
 Plot_plotsTPR.C:889
 Plot_plotsTPR.C:890
 Plot_plotsTPR.C:891
 Plot_plotsTPR.C:892
 Plot_plotsTPR.C:893
 Plot_plotsTPR.C:894
 Plot_plotsTPR.C:895
 Plot_plotsTPR.C:896
 Plot_plotsTPR.C:897
 Plot_plotsTPR.C:898
 Plot_plotsTPR.C:899
 Plot_plotsTPR.C:900
 Plot_plotsTPR.C:901
 Plot_plotsTPR.C:902
 Plot_plotsTPR.C:903
 Plot_plotsTPR.C:904
 Plot_plotsTPR.C:905
 Plot_plotsTPR.C:906
 Plot_plotsTPR.C:907
 Plot_plotsTPR.C:908
 Plot_plotsTPR.C:909
 Plot_plotsTPR.C:910
 Plot_plotsTPR.C:911
 Plot_plotsTPR.C:912
 Plot_plotsTPR.C:913
 Plot_plotsTPR.C:914
 Plot_plotsTPR.C:915
 Plot_plotsTPR.C:916
 Plot_plotsTPR.C:917
 Plot_plotsTPR.C:918
 Plot_plotsTPR.C:919
 Plot_plotsTPR.C:920
 Plot_plotsTPR.C:921
 Plot_plotsTPR.C:922
 Plot_plotsTPR.C:923
 Plot_plotsTPR.C:924
 Plot_plotsTPR.C:925
 Plot_plotsTPR.C:926
 Plot_plotsTPR.C:927
 Plot_plotsTPR.C:928
 Plot_plotsTPR.C:929
 Plot_plotsTPR.C:930
 Plot_plotsTPR.C:931
 Plot_plotsTPR.C:932
 Plot_plotsTPR.C:933
 Plot_plotsTPR.C:934
 Plot_plotsTPR.C:935
 Plot_plotsTPR.C:936
 Plot_plotsTPR.C:937
 Plot_plotsTPR.C:938
 Plot_plotsTPR.C:939
 Plot_plotsTPR.C:940
 Plot_plotsTPR.C:941
 Plot_plotsTPR.C:942
 Plot_plotsTPR.C:943
 Plot_plotsTPR.C:944
 Plot_plotsTPR.C:945
 Plot_plotsTPR.C:946
 Plot_plotsTPR.C:947
 Plot_plotsTPR.C:948
 Plot_plotsTPR.C:949
 Plot_plotsTPR.C:950
 Plot_plotsTPR.C:951
 Plot_plotsTPR.C:952
 Plot_plotsTPR.C:953
 Plot_plotsTPR.C:954
 Plot_plotsTPR.C:955
 Plot_plotsTPR.C:956
 Plot_plotsTPR.C:957
 Plot_plotsTPR.C:958
 Plot_plotsTPR.C:959
 Plot_plotsTPR.C:960
 Plot_plotsTPR.C:961
 Plot_plotsTPR.C:962
 Plot_plotsTPR.C:963
 Plot_plotsTPR.C:964
 Plot_plotsTPR.C:965
 Plot_plotsTPR.C:966
 Plot_plotsTPR.C:967
 Plot_plotsTPR.C:968
 Plot_plotsTPR.C:969
 Plot_plotsTPR.C:970
 Plot_plotsTPR.C:971
 Plot_plotsTPR.C:972
 Plot_plotsTPR.C:973
 Plot_plotsTPR.C:974
 Plot_plotsTPR.C:975
 Plot_plotsTPR.C:976
 Plot_plotsTPR.C:977
 Plot_plotsTPR.C:978
 Plot_plotsTPR.C:979
 Plot_plotsTPR.C:980
 Plot_plotsTPR.C:981
 Plot_plotsTPR.C:982
 Plot_plotsTPR.C:983
 Plot_plotsTPR.C:984
 Plot_plotsTPR.C:985
 Plot_plotsTPR.C:986
 Plot_plotsTPR.C:987
 Plot_plotsTPR.C:988
 Plot_plotsTPR.C:989
 Plot_plotsTPR.C:990
 Plot_plotsTPR.C:991
 Plot_plotsTPR.C:992
 Plot_plotsTPR.C:993
 Plot_plotsTPR.C:994
 Plot_plotsTPR.C:995
 Plot_plotsTPR.C:996
 Plot_plotsTPR.C:997
 Plot_plotsTPR.C:998
 Plot_plotsTPR.C:999
 Plot_plotsTPR.C:1000
 Plot_plotsTPR.C:1001
 Plot_plotsTPR.C:1002
 Plot_plotsTPR.C:1003
 Plot_plotsTPR.C:1004
 Plot_plotsTPR.C:1005
 Plot_plotsTPR.C:1006
 Plot_plotsTPR.C:1007
 Plot_plotsTPR.C:1008
 Plot_plotsTPR.C:1009
 Plot_plotsTPR.C:1010
 Plot_plotsTPR.C:1011
 Plot_plotsTPR.C:1012
 Plot_plotsTPR.C:1013
 Plot_plotsTPR.C:1014
 Plot_plotsTPR.C:1015
 Plot_plotsTPR.C:1016
 Plot_plotsTPR.C:1017
 Plot_plotsTPR.C:1018
 Plot_plotsTPR.C:1019
 Plot_plotsTPR.C:1020
 Plot_plotsTPR.C:1021
 Plot_plotsTPR.C:1022
 Plot_plotsTPR.C:1023
 Plot_plotsTPR.C:1024
 Plot_plotsTPR.C:1025
 Plot_plotsTPR.C:1026
 Plot_plotsTPR.C:1027
 Plot_plotsTPR.C:1028
 Plot_plotsTPR.C:1029
 Plot_plotsTPR.C:1030
 Plot_plotsTPR.C:1031
 Plot_plotsTPR.C:1032
 Plot_plotsTPR.C:1033
 Plot_plotsTPR.C:1034
 Plot_plotsTPR.C:1035
 Plot_plotsTPR.C:1036
 Plot_plotsTPR.C:1037
 Plot_plotsTPR.C:1038
 Plot_plotsTPR.C:1039
 Plot_plotsTPR.C:1040
 Plot_plotsTPR.C:1041
 Plot_plotsTPR.C:1042
 Plot_plotsTPR.C:1043
 Plot_plotsTPR.C:1044
 Plot_plotsTPR.C:1045
 Plot_plotsTPR.C:1046
 Plot_plotsTPR.C:1047
 Plot_plotsTPR.C:1048
 Plot_plotsTPR.C:1049
 Plot_plotsTPR.C:1050
 Plot_plotsTPR.C:1051
 Plot_plotsTPR.C:1052
 Plot_plotsTPR.C:1053
 Plot_plotsTPR.C:1054
 Plot_plotsTPR.C:1055
 Plot_plotsTPR.C:1056
 Plot_plotsTPR.C:1057
 Plot_plotsTPR.C:1058
 Plot_plotsTPR.C:1059
 Plot_plotsTPR.C:1060
 Plot_plotsTPR.C:1061
 Plot_plotsTPR.C:1062
 Plot_plotsTPR.C:1063
 Plot_plotsTPR.C:1064
 Plot_plotsTPR.C:1065
 Plot_plotsTPR.C:1066
 Plot_plotsTPR.C:1067
 Plot_plotsTPR.C:1068
 Plot_plotsTPR.C:1069
 Plot_plotsTPR.C:1070
 Plot_plotsTPR.C:1071
 Plot_plotsTPR.C:1072
 Plot_plotsTPR.C:1073
 Plot_plotsTPR.C:1074
 Plot_plotsTPR.C:1075
 Plot_plotsTPR.C:1076
 Plot_plotsTPR.C:1077
 Plot_plotsTPR.C:1078
 Plot_plotsTPR.C:1079
 Plot_plotsTPR.C:1080
 Plot_plotsTPR.C:1081
 Plot_plotsTPR.C:1082
 Plot_plotsTPR.C:1083
 Plot_plotsTPR.C:1084
 Plot_plotsTPR.C:1085
 Plot_plotsTPR.C:1086
 Plot_plotsTPR.C:1087
 Plot_plotsTPR.C:1088
 Plot_plotsTPR.C:1089
 Plot_plotsTPR.C:1090
 Plot_plotsTPR.C:1091
 Plot_plotsTPR.C:1092
 Plot_plotsTPR.C:1093
 Plot_plotsTPR.C:1094
 Plot_plotsTPR.C:1095
 Plot_plotsTPR.C:1096
 Plot_plotsTPR.C:1097
 Plot_plotsTPR.C:1098
 Plot_plotsTPR.C:1099
 Plot_plotsTPR.C:1100
 Plot_plotsTPR.C:1101
 Plot_plotsTPR.C:1102
 Plot_plotsTPR.C:1103
 Plot_plotsTPR.C:1104
 Plot_plotsTPR.C:1105
 Plot_plotsTPR.C:1106
 Plot_plotsTPR.C:1107
 Plot_plotsTPR.C:1108
 Plot_plotsTPR.C:1109
 Plot_plotsTPR.C:1110
 Plot_plotsTPR.C:1111
 Plot_plotsTPR.C:1112
 Plot_plotsTPR.C:1113
 Plot_plotsTPR.C:1114
 Plot_plotsTPR.C:1115
 Plot_plotsTPR.C:1116
 Plot_plotsTPR.C:1117
 Plot_plotsTPR.C:1118
 Plot_plotsTPR.C:1119
 Plot_plotsTPR.C:1120
 Plot_plotsTPR.C:1121
 Plot_plotsTPR.C:1122
 Plot_plotsTPR.C:1123
 Plot_plotsTPR.C:1124
 Plot_plotsTPR.C:1125
 Plot_plotsTPR.C:1126
 Plot_plotsTPR.C:1127
 Plot_plotsTPR.C:1128
 Plot_plotsTPR.C:1129
 Plot_plotsTPR.C:1130
 Plot_plotsTPR.C:1131
 Plot_plotsTPR.C:1132
 Plot_plotsTPR.C:1133
 Plot_plotsTPR.C:1134
 Plot_plotsTPR.C:1135
 Plot_plotsTPR.C:1136
 Plot_plotsTPR.C:1137
 Plot_plotsTPR.C:1138
 Plot_plotsTPR.C:1139
 Plot_plotsTPR.C:1140
 Plot_plotsTPR.C:1141
 Plot_plotsTPR.C:1142
 Plot_plotsTPR.C:1143
 Plot_plotsTPR.C:1144
 Plot_plotsTPR.C:1145
 Plot_plotsTPR.C:1146
 Plot_plotsTPR.C:1147
 Plot_plotsTPR.C:1148
 Plot_plotsTPR.C:1149
 Plot_plotsTPR.C:1150
 Plot_plotsTPR.C:1151
 Plot_plotsTPR.C:1152
 Plot_plotsTPR.C:1153
 Plot_plotsTPR.C:1154
 Plot_plotsTPR.C:1155
 Plot_plotsTPR.C:1156
 Plot_plotsTPR.C:1157
 Plot_plotsTPR.C:1158
 Plot_plotsTPR.C:1159
 Plot_plotsTPR.C:1160
 Plot_plotsTPR.C:1161
 Plot_plotsTPR.C:1162
 Plot_plotsTPR.C:1163
 Plot_plotsTPR.C:1164
 Plot_plotsTPR.C:1165
 Plot_plotsTPR.C:1166
 Plot_plotsTPR.C:1167
 Plot_plotsTPR.C:1168
 Plot_plotsTPR.C:1169
 Plot_plotsTPR.C:1170
 Plot_plotsTPR.C:1171
 Plot_plotsTPR.C:1172
 Plot_plotsTPR.C:1173
 Plot_plotsTPR.C:1174
 Plot_plotsTPR.C:1175
 Plot_plotsTPR.C:1176
 Plot_plotsTPR.C:1177
 Plot_plotsTPR.C:1178
 Plot_plotsTPR.C:1179
 Plot_plotsTPR.C:1180
 Plot_plotsTPR.C:1181
 Plot_plotsTPR.C:1182
 Plot_plotsTPR.C:1183
 Plot_plotsTPR.C:1184
 Plot_plotsTPR.C:1185
 Plot_plotsTPR.C:1186
 Plot_plotsTPR.C:1187
 Plot_plotsTPR.C:1188
 Plot_plotsTPR.C:1189
 Plot_plotsTPR.C:1190
 Plot_plotsTPR.C:1191
 Plot_plotsTPR.C:1192
 Plot_plotsTPR.C:1193
 Plot_plotsTPR.C:1194
 Plot_plotsTPR.C:1195
 Plot_plotsTPR.C:1196
 Plot_plotsTPR.C:1197
 Plot_plotsTPR.C:1198
 Plot_plotsTPR.C:1199
 Plot_plotsTPR.C:1200
 Plot_plotsTPR.C:1201
 Plot_plotsTPR.C:1202
 Plot_plotsTPR.C:1203
 Plot_plotsTPR.C:1204
 Plot_plotsTPR.C:1205
 Plot_plotsTPR.C:1206
 Plot_plotsTPR.C:1207
 Plot_plotsTPR.C:1208
 Plot_plotsTPR.C:1209
 Plot_plotsTPR.C:1210
 Plot_plotsTPR.C:1211
 Plot_plotsTPR.C:1212
 Plot_plotsTPR.C:1213
 Plot_plotsTPR.C:1214
 Plot_plotsTPR.C:1215
 Plot_plotsTPR.C:1216
 Plot_plotsTPR.C:1217
 Plot_plotsTPR.C:1218
 Plot_plotsTPR.C:1219
 Plot_plotsTPR.C:1220
 Plot_plotsTPR.C:1221
 Plot_plotsTPR.C:1222
 Plot_plotsTPR.C:1223
 Plot_plotsTPR.C:1224
 Plot_plotsTPR.C:1225
 Plot_plotsTPR.C:1226
 Plot_plotsTPR.C:1227
 Plot_plotsTPR.C:1228
 Plot_plotsTPR.C:1229
 Plot_plotsTPR.C:1230
 Plot_plotsTPR.C:1231
 Plot_plotsTPR.C:1232
 Plot_plotsTPR.C:1233
 Plot_plotsTPR.C:1234
 Plot_plotsTPR.C:1235
 Plot_plotsTPR.C:1236
 Plot_plotsTPR.C:1237
 Plot_plotsTPR.C:1238
 Plot_plotsTPR.C:1239
 Plot_plotsTPR.C:1240
 Plot_plotsTPR.C:1241
 Plot_plotsTPR.C:1242
 Plot_plotsTPR.C:1243
 Plot_plotsTPR.C:1244
 Plot_plotsTPR.C:1245
 Plot_plotsTPR.C:1246
 Plot_plotsTPR.C:1247
 Plot_plotsTPR.C:1248
 Plot_plotsTPR.C:1249
 Plot_plotsTPR.C:1250
 Plot_plotsTPR.C:1251
 Plot_plotsTPR.C:1252
 Plot_plotsTPR.C:1253
 Plot_plotsTPR.C:1254
 Plot_plotsTPR.C:1255
 Plot_plotsTPR.C:1256
 Plot_plotsTPR.C:1257
 Plot_plotsTPR.C:1258
 Plot_plotsTPR.C:1259
 Plot_plotsTPR.C:1260
 Plot_plotsTPR.C:1261
 Plot_plotsTPR.C:1262
 Plot_plotsTPR.C:1263
 Plot_plotsTPR.C:1264
 Plot_plotsTPR.C:1265
 Plot_plotsTPR.C:1266
 Plot_plotsTPR.C:1267
 Plot_plotsTPR.C:1268
 Plot_plotsTPR.C:1269
 Plot_plotsTPR.C:1270
 Plot_plotsTPR.C:1271
 Plot_plotsTPR.C:1272
 Plot_plotsTPR.C:1273
 Plot_plotsTPR.C:1274
 Plot_plotsTPR.C:1275
 Plot_plotsTPR.C:1276
 Plot_plotsTPR.C:1277
 Plot_plotsTPR.C:1278
 Plot_plotsTPR.C:1279
 Plot_plotsTPR.C:1280
 Plot_plotsTPR.C:1281
 Plot_plotsTPR.C:1282
 Plot_plotsTPR.C:1283
 Plot_plotsTPR.C:1284
 Plot_plotsTPR.C:1285
 Plot_plotsTPR.C:1286
 Plot_plotsTPR.C:1287
 Plot_plotsTPR.C:1288
 Plot_plotsTPR.C:1289
 Plot_plotsTPR.C:1290
 Plot_plotsTPR.C:1291
 Plot_plotsTPR.C:1292
 Plot_plotsTPR.C:1293
 Plot_plotsTPR.C:1294
 Plot_plotsTPR.C:1295
 Plot_plotsTPR.C:1296
 Plot_plotsTPR.C:1297
 Plot_plotsTPR.C:1298
 Plot_plotsTPR.C:1299
 Plot_plotsTPR.C:1300
 Plot_plotsTPR.C:1301
 Plot_plotsTPR.C:1302
 Plot_plotsTPR.C:1303
 Plot_plotsTPR.C:1304
 Plot_plotsTPR.C:1305
 Plot_plotsTPR.C:1306
 Plot_plotsTPR.C:1307
 Plot_plotsTPR.C:1308
 Plot_plotsTPR.C:1309
 Plot_plotsTPR.C:1310
 Plot_plotsTPR.C:1311
 Plot_plotsTPR.C:1312
 Plot_plotsTPR.C:1313
 Plot_plotsTPR.C:1314
 Plot_plotsTPR.C:1315
 Plot_plotsTPR.C:1316
 Plot_plotsTPR.C:1317
 Plot_plotsTPR.C:1318
 Plot_plotsTPR.C:1319
 Plot_plotsTPR.C:1320
 Plot_plotsTPR.C:1321
 Plot_plotsTPR.C:1322
 Plot_plotsTPR.C:1323
 Plot_plotsTPR.C:1324
 Plot_plotsTPR.C:1325
 Plot_plotsTPR.C:1326
 Plot_plotsTPR.C:1327
 Plot_plotsTPR.C:1328
 Plot_plotsTPR.C:1329
 Plot_plotsTPR.C:1330
 Plot_plotsTPR.C:1331
 Plot_plotsTPR.C:1332
 Plot_plotsTPR.C:1333
 Plot_plotsTPR.C:1334
 Plot_plotsTPR.C:1335
 Plot_plotsTPR.C:1336
 Plot_plotsTPR.C:1337
 Plot_plotsTPR.C:1338
 Plot_plotsTPR.C:1339
 Plot_plotsTPR.C:1340
 Plot_plotsTPR.C:1341
 Plot_plotsTPR.C:1342
 Plot_plotsTPR.C:1343
 Plot_plotsTPR.C:1344
 Plot_plotsTPR.C:1345
 Plot_plotsTPR.C:1346
 Plot_plotsTPR.C:1347
 Plot_plotsTPR.C:1348
 Plot_plotsTPR.C:1349
 Plot_plotsTPR.C:1350
 Plot_plotsTPR.C:1351
 Plot_plotsTPR.C:1352
 Plot_plotsTPR.C:1353
 Plot_plotsTPR.C:1354
 Plot_plotsTPR.C:1355
 Plot_plotsTPR.C:1356
 Plot_plotsTPR.C:1357
 Plot_plotsTPR.C:1358
 Plot_plotsTPR.C:1359
 Plot_plotsTPR.C:1360
 Plot_plotsTPR.C:1361
 Plot_plotsTPR.C:1362
 Plot_plotsTPR.C:1363
 Plot_plotsTPR.C:1364
 Plot_plotsTPR.C:1365
 Plot_plotsTPR.C:1366
 Plot_plotsTPR.C:1367
 Plot_plotsTPR.C:1368
 Plot_plotsTPR.C:1369
 Plot_plotsTPR.C:1370
 Plot_plotsTPR.C:1371
 Plot_plotsTPR.C:1372
 Plot_plotsTPR.C:1373
 Plot_plotsTPR.C:1374
 Plot_plotsTPR.C:1375
 Plot_plotsTPR.C:1376
 Plot_plotsTPR.C:1377
 Plot_plotsTPR.C:1378
 Plot_plotsTPR.C:1379
 Plot_plotsTPR.C:1380
 Plot_plotsTPR.C:1381
 Plot_plotsTPR.C:1382
 Plot_plotsTPR.C:1383
 Plot_plotsTPR.C:1384
 Plot_plotsTPR.C:1385
 Plot_plotsTPR.C:1386
 Plot_plotsTPR.C:1387
 Plot_plotsTPR.C:1388
 Plot_plotsTPR.C:1389
 Plot_plotsTPR.C:1390
 Plot_plotsTPR.C:1391
 Plot_plotsTPR.C:1392
 Plot_plotsTPR.C:1393
 Plot_plotsTPR.C:1394
 Plot_plotsTPR.C:1395
 Plot_plotsTPR.C:1396
 Plot_plotsTPR.C:1397
 Plot_plotsTPR.C:1398
 Plot_plotsTPR.C:1399
 Plot_plotsTPR.C:1400
 Plot_plotsTPR.C:1401
 Plot_plotsTPR.C:1402
 Plot_plotsTPR.C:1403
 Plot_plotsTPR.C:1404
 Plot_plotsTPR.C:1405
 Plot_plotsTPR.C:1406
 Plot_plotsTPR.C:1407
 Plot_plotsTPR.C:1408
 Plot_plotsTPR.C:1409
 Plot_plotsTPR.C:1410
 Plot_plotsTPR.C:1411
 Plot_plotsTPR.C:1412
 Plot_plotsTPR.C:1413
 Plot_plotsTPR.C:1414
 Plot_plotsTPR.C:1415
 Plot_plotsTPR.C:1416
 Plot_plotsTPR.C:1417
 Plot_plotsTPR.C:1418
 Plot_plotsTPR.C:1419
 Plot_plotsTPR.C:1420
 Plot_plotsTPR.C:1421
 Plot_plotsTPR.C:1422
 Plot_plotsTPR.C:1423
 Plot_plotsTPR.C:1424
 Plot_plotsTPR.C:1425
 Plot_plotsTPR.C:1426
 Plot_plotsTPR.C:1427
 Plot_plotsTPR.C:1428
 Plot_plotsTPR.C:1429
 Plot_plotsTPR.C:1430
 Plot_plotsTPR.C:1431
 Plot_plotsTPR.C:1432
 Plot_plotsTPR.C:1433
 Plot_plotsTPR.C:1434
 Plot_plotsTPR.C:1435
 Plot_plotsTPR.C:1436
 Plot_plotsTPR.C:1437
 Plot_plotsTPR.C:1438
 Plot_plotsTPR.C:1439
 Plot_plotsTPR.C:1440
 Plot_plotsTPR.C:1441
 Plot_plotsTPR.C:1442
 Plot_plotsTPR.C:1443
 Plot_plotsTPR.C:1444
 Plot_plotsTPR.C:1445
 Plot_plotsTPR.C:1446
 Plot_plotsTPR.C:1447
 Plot_plotsTPR.C:1448
 Plot_plotsTPR.C:1449
 Plot_plotsTPR.C:1450
 Plot_plotsTPR.C:1451
 Plot_plotsTPR.C:1452
 Plot_plotsTPR.C:1453
 Plot_plotsTPR.C:1454
 Plot_plotsTPR.C:1455
 Plot_plotsTPR.C:1456
 Plot_plotsTPR.C:1457
 Plot_plotsTPR.C:1458
 Plot_plotsTPR.C:1459
 Plot_plotsTPR.C:1460
 Plot_plotsTPR.C:1461
 Plot_plotsTPR.C:1462
 Plot_plotsTPR.C:1463
 Plot_plotsTPR.C:1464
 Plot_plotsTPR.C:1465
 Plot_plotsTPR.C:1466
 Plot_plotsTPR.C:1467
 Plot_plotsTPR.C:1468
 Plot_plotsTPR.C:1469
 Plot_plotsTPR.C:1470
 Plot_plotsTPR.C:1471
 Plot_plotsTPR.C:1472
 Plot_plotsTPR.C:1473
 Plot_plotsTPR.C:1474
 Plot_plotsTPR.C:1475
 Plot_plotsTPR.C:1476
 Plot_plotsTPR.C:1477
 Plot_plotsTPR.C:1478
 Plot_plotsTPR.C:1479
 Plot_plotsTPR.C:1480
 Plot_plotsTPR.C:1481
 Plot_plotsTPR.C:1482
 Plot_plotsTPR.C:1483
 Plot_plotsTPR.C:1484
 Plot_plotsTPR.C:1485
 Plot_plotsTPR.C:1486
 Plot_plotsTPR.C:1487
 Plot_plotsTPR.C:1488
 Plot_plotsTPR.C:1489
 Plot_plotsTPR.C:1490
 Plot_plotsTPR.C:1491
 Plot_plotsTPR.C:1492
 Plot_plotsTPR.C:1493
 Plot_plotsTPR.C:1494
 Plot_plotsTPR.C:1495
 Plot_plotsTPR.C:1496
 Plot_plotsTPR.C:1497
 Plot_plotsTPR.C:1498
 Plot_plotsTPR.C:1499
 Plot_plotsTPR.C:1500
 Plot_plotsTPR.C:1501
 Plot_plotsTPR.C:1502
 Plot_plotsTPR.C:1503
 Plot_plotsTPR.C:1504
 Plot_plotsTPR.C:1505
 Plot_plotsTPR.C:1506
 Plot_plotsTPR.C:1507
 Plot_plotsTPR.C:1508
 Plot_plotsTPR.C:1509
 Plot_plotsTPR.C:1510
 Plot_plotsTPR.C:1511
 Plot_plotsTPR.C:1512
 Plot_plotsTPR.C:1513
 Plot_plotsTPR.C:1514
 Plot_plotsTPR.C:1515
 Plot_plotsTPR.C:1516
 Plot_plotsTPR.C:1517
 Plot_plotsTPR.C:1518
 Plot_plotsTPR.C:1519
 Plot_plotsTPR.C:1520
 Plot_plotsTPR.C:1521
 Plot_plotsTPR.C:1522
 Plot_plotsTPR.C:1523
 Plot_plotsTPR.C:1524
 Plot_plotsTPR.C:1525
 Plot_plotsTPR.C:1526
 Plot_plotsTPR.C:1527
 Plot_plotsTPR.C:1528
 Plot_plotsTPR.C:1529
 Plot_plotsTPR.C:1530
 Plot_plotsTPR.C:1531
 Plot_plotsTPR.C:1532
 Plot_plotsTPR.C:1533
 Plot_plotsTPR.C:1534
 Plot_plotsTPR.C:1535
 Plot_plotsTPR.C:1536
 Plot_plotsTPR.C:1537
 Plot_plotsTPR.C:1538
 Plot_plotsTPR.C:1539
 Plot_plotsTPR.C:1540
 Plot_plotsTPR.C:1541
 Plot_plotsTPR.C:1542
 Plot_plotsTPR.C:1543
 Plot_plotsTPR.C:1544
 Plot_plotsTPR.C:1545
 Plot_plotsTPR.C:1546
 Plot_plotsTPR.C:1547
 Plot_plotsTPR.C:1548
 Plot_plotsTPR.C:1549
 Plot_plotsTPR.C:1550
 Plot_plotsTPR.C:1551
 Plot_plotsTPR.C:1552
 Plot_plotsTPR.C:1553
 Plot_plotsTPR.C:1554
 Plot_plotsTPR.C:1555
 Plot_plotsTPR.C:1556
 Plot_plotsTPR.C:1557
 Plot_plotsTPR.C:1558
 Plot_plotsTPR.C:1559
 Plot_plotsTPR.C:1560
 Plot_plotsTPR.C:1561
 Plot_plotsTPR.C:1562
 Plot_plotsTPR.C:1563
 Plot_plotsTPR.C:1564
 Plot_plotsTPR.C:1565
 Plot_plotsTPR.C:1566
 Plot_plotsTPR.C:1567
 Plot_plotsTPR.C:1568
 Plot_plotsTPR.C:1569
 Plot_plotsTPR.C:1570
 Plot_plotsTPR.C:1571
 Plot_plotsTPR.C:1572
 Plot_plotsTPR.C:1573
 Plot_plotsTPR.C:1574
 Plot_plotsTPR.C:1575
 Plot_plotsTPR.C:1576
 Plot_plotsTPR.C:1577
 Plot_plotsTPR.C:1578
 Plot_plotsTPR.C:1579
 Plot_plotsTPR.C:1580
 Plot_plotsTPR.C:1581
 Plot_plotsTPR.C:1582
 Plot_plotsTPR.C:1583
 Plot_plotsTPR.C:1584
 Plot_plotsTPR.C:1585
 Plot_plotsTPR.C:1586
 Plot_plotsTPR.C:1587
 Plot_plotsTPR.C:1588
 Plot_plotsTPR.C:1589
 Plot_plotsTPR.C:1590
 Plot_plotsTPR.C:1591
 Plot_plotsTPR.C:1592
 Plot_plotsTPR.C:1593
 Plot_plotsTPR.C:1594
 Plot_plotsTPR.C:1595
 Plot_plotsTPR.C:1596
 Plot_plotsTPR.C:1597
 Plot_plotsTPR.C:1598
 Plot_plotsTPR.C:1599
 Plot_plotsTPR.C:1600
 Plot_plotsTPR.C:1601
 Plot_plotsTPR.C:1602
 Plot_plotsTPR.C:1603
 Plot_plotsTPR.C:1604
 Plot_plotsTPR.C:1605
 Plot_plotsTPR.C:1606
 Plot_plotsTPR.C:1607
 Plot_plotsTPR.C:1608
 Plot_plotsTPR.C:1609
 Plot_plotsTPR.C:1610
 Plot_plotsTPR.C:1611
 Plot_plotsTPR.C:1612
 Plot_plotsTPR.C:1613
 Plot_plotsTPR.C:1614
 Plot_plotsTPR.C:1615
 Plot_plotsTPR.C:1616
 Plot_plotsTPR.C:1617
 Plot_plotsTPR.C:1618
 Plot_plotsTPR.C:1619
 Plot_plotsTPR.C:1620
 Plot_plotsTPR.C:1621
 Plot_plotsTPR.C:1622
 Plot_plotsTPR.C:1623
 Plot_plotsTPR.C:1624
 Plot_plotsTPR.C:1625
 Plot_plotsTPR.C:1626
 Plot_plotsTPR.C:1627
 Plot_plotsTPR.C:1628
 Plot_plotsTPR.C:1629
 Plot_plotsTPR.C:1630
 Plot_plotsTPR.C:1631
 Plot_plotsTPR.C:1632
 Plot_plotsTPR.C:1633
 Plot_plotsTPR.C:1634
 Plot_plotsTPR.C:1635
 Plot_plotsTPR.C:1636
 Plot_plotsTPR.C:1637
 Plot_plotsTPR.C:1638
 Plot_plotsTPR.C:1639
 Plot_plotsTPR.C:1640
 Plot_plotsTPR.C:1641
 Plot_plotsTPR.C:1642
 Plot_plotsTPR.C:1643
 Plot_plotsTPR.C:1644
 Plot_plotsTPR.C:1645
 Plot_plotsTPR.C:1646
 Plot_plotsTPR.C:1647
 Plot_plotsTPR.C:1648
 Plot_plotsTPR.C:1649
 Plot_plotsTPR.C:1650
 Plot_plotsTPR.C:1651
 Plot_plotsTPR.C:1652
 Plot_plotsTPR.C:1653
 Plot_plotsTPR.C:1654
 Plot_plotsTPR.C:1655
 Plot_plotsTPR.C:1656
 Plot_plotsTPR.C:1657
 Plot_plotsTPR.C:1658
 Plot_plotsTPR.C:1659
 Plot_plotsTPR.C:1660
 Plot_plotsTPR.C:1661
 Plot_plotsTPR.C:1662
 Plot_plotsTPR.C:1663
 Plot_plotsTPR.C:1664
 Plot_plotsTPR.C:1665
 Plot_plotsTPR.C:1666
 Plot_plotsTPR.C:1667
 Plot_plotsTPR.C:1668
 Plot_plotsTPR.C:1669
 Plot_plotsTPR.C:1670
 Plot_plotsTPR.C:1671
 Plot_plotsTPR.C:1672
 Plot_plotsTPR.C:1673
 Plot_plotsTPR.C:1674
 Plot_plotsTPR.C:1675
 Plot_plotsTPR.C:1676
 Plot_plotsTPR.C:1677
 Plot_plotsTPR.C:1678
 Plot_plotsTPR.C:1679
 Plot_plotsTPR.C:1680
 Plot_plotsTPR.C:1681
 Plot_plotsTPR.C:1682
 Plot_plotsTPR.C:1683
 Plot_plotsTPR.C:1684
 Plot_plotsTPR.C:1685
 Plot_plotsTPR.C:1686
 Plot_plotsTPR.C:1687
 Plot_plotsTPR.C:1688
 Plot_plotsTPR.C:1689
 Plot_plotsTPR.C:1690
 Plot_plotsTPR.C:1691
 Plot_plotsTPR.C:1692
 Plot_plotsTPR.C:1693
 Plot_plotsTPR.C:1694
 Plot_plotsTPR.C:1695
 Plot_plotsTPR.C:1696
 Plot_plotsTPR.C:1697
 Plot_plotsTPR.C:1698
 Plot_plotsTPR.C:1699
 Plot_plotsTPR.C:1700
 Plot_plotsTPR.C:1701
 Plot_plotsTPR.C:1702
 Plot_plotsTPR.C:1703
 Plot_plotsTPR.C:1704
 Plot_plotsTPR.C:1705
 Plot_plotsTPR.C:1706
 Plot_plotsTPR.C:1707
 Plot_plotsTPR.C:1708
 Plot_plotsTPR.C:1709
 Plot_plotsTPR.C:1710
 Plot_plotsTPR.C:1711
 Plot_plotsTPR.C:1712
 Plot_plotsTPR.C:1713
 Plot_plotsTPR.C:1714
 Plot_plotsTPR.C:1715
 Plot_plotsTPR.C:1716
 Plot_plotsTPR.C:1717
 Plot_plotsTPR.C:1718
 Plot_plotsTPR.C:1719
 Plot_plotsTPR.C:1720
 Plot_plotsTPR.C:1721
 Plot_plotsTPR.C:1722
 Plot_plotsTPR.C:1723
 Plot_plotsTPR.C:1724
 Plot_plotsTPR.C:1725
 Plot_plotsTPR.C:1726
 Plot_plotsTPR.C:1727
 Plot_plotsTPR.C:1728
 Plot_plotsTPR.C:1729
 Plot_plotsTPR.C:1730
 Plot_plotsTPR.C:1731
 Plot_plotsTPR.C:1732
 Plot_plotsTPR.C:1733
 Plot_plotsTPR.C:1734
 Plot_plotsTPR.C:1735
 Plot_plotsTPR.C:1736
 Plot_plotsTPR.C:1737
 Plot_plotsTPR.C:1738
 Plot_plotsTPR.C:1739
 Plot_plotsTPR.C:1740
 Plot_plotsTPR.C:1741
 Plot_plotsTPR.C:1742
 Plot_plotsTPR.C:1743
 Plot_plotsTPR.C:1744
 Plot_plotsTPR.C:1745
 Plot_plotsTPR.C:1746
 Plot_plotsTPR.C:1747
 Plot_plotsTPR.C:1748
 Plot_plotsTPR.C:1749
 Plot_plotsTPR.C:1750
 Plot_plotsTPR.C:1751
 Plot_plotsTPR.C:1752
 Plot_plotsTPR.C:1753
 Plot_plotsTPR.C:1754
 Plot_plotsTPR.C:1755
 Plot_plotsTPR.C:1756
 Plot_plotsTPR.C:1757
 Plot_plotsTPR.C:1758
 Plot_plotsTPR.C:1759
 Plot_plotsTPR.C:1760
 Plot_plotsTPR.C:1761
 Plot_plotsTPR.C:1762
 Plot_plotsTPR.C:1763
 Plot_plotsTPR.C:1764
 Plot_plotsTPR.C:1765
 Plot_plotsTPR.C:1766
 Plot_plotsTPR.C:1767
 Plot_plotsTPR.C:1768
 Plot_plotsTPR.C:1769
 Plot_plotsTPR.C:1770
 Plot_plotsTPR.C:1771
 Plot_plotsTPR.C:1772
 Plot_plotsTPR.C:1773
 Plot_plotsTPR.C:1774
 Plot_plotsTPR.C:1775
 Plot_plotsTPR.C:1776
 Plot_plotsTPR.C:1777
 Plot_plotsTPR.C:1778
 Plot_plotsTPR.C:1779
 Plot_plotsTPR.C:1780
 Plot_plotsTPR.C:1781
 Plot_plotsTPR.C:1782
 Plot_plotsTPR.C:1783
 Plot_plotsTPR.C:1784
 Plot_plotsTPR.C:1785
 Plot_plotsTPR.C:1786
 Plot_plotsTPR.C:1787
 Plot_plotsTPR.C:1788
 Plot_plotsTPR.C:1789
 Plot_plotsTPR.C:1790
 Plot_plotsTPR.C:1791
 Plot_plotsTPR.C:1792
 Plot_plotsTPR.C:1793
 Plot_plotsTPR.C:1794
 Plot_plotsTPR.C:1795
 Plot_plotsTPR.C:1796
 Plot_plotsTPR.C:1797
 Plot_plotsTPR.C:1798
 Plot_plotsTPR.C:1799
 Plot_plotsTPR.C:1800
 Plot_plotsTPR.C:1801
 Plot_plotsTPR.C:1802
 Plot_plotsTPR.C:1803
 Plot_plotsTPR.C:1804
 Plot_plotsTPR.C:1805
 Plot_plotsTPR.C:1806
 Plot_plotsTPR.C:1807
 Plot_plotsTPR.C:1808
 Plot_plotsTPR.C:1809
 Plot_plotsTPR.C:1810
 Plot_plotsTPR.C:1811
 Plot_plotsTPR.C:1812
 Plot_plotsTPR.C:1813
 Plot_plotsTPR.C:1814
 Plot_plotsTPR.C:1815
 Plot_plotsTPR.C:1816
 Plot_plotsTPR.C:1817
 Plot_plotsTPR.C:1818
 Plot_plotsTPR.C:1819
 Plot_plotsTPR.C:1820
 Plot_plotsTPR.C:1821
 Plot_plotsTPR.C:1822
 Plot_plotsTPR.C:1823
 Plot_plotsTPR.C:1824
 Plot_plotsTPR.C:1825
 Plot_plotsTPR.C:1826
 Plot_plotsTPR.C:1827
 Plot_plotsTPR.C:1828
 Plot_plotsTPR.C:1829
 Plot_plotsTPR.C:1830
 Plot_plotsTPR.C:1831
 Plot_plotsTPR.C:1832
 Plot_plotsTPR.C:1833
 Plot_plotsTPR.C:1834
 Plot_plotsTPR.C:1835
 Plot_plotsTPR.C:1836
 Plot_plotsTPR.C:1837
 Plot_plotsTPR.C:1838
 Plot_plotsTPR.C:1839
 Plot_plotsTPR.C:1840
 Plot_plotsTPR.C:1841
 Plot_plotsTPR.C:1842
 Plot_plotsTPR.C:1843
 Plot_plotsTPR.C:1844
 Plot_plotsTPR.C:1845
 Plot_plotsTPR.C:1846
 Plot_plotsTPR.C:1847
 Plot_plotsTPR.C:1848
 Plot_plotsTPR.C:1849
 Plot_plotsTPR.C:1850
 Plot_plotsTPR.C:1851
 Plot_plotsTPR.C:1852
 Plot_plotsTPR.C:1853
 Plot_plotsTPR.C:1854
 Plot_plotsTPR.C:1855
 Plot_plotsTPR.C:1856
 Plot_plotsTPR.C:1857
 Plot_plotsTPR.C:1858
 Plot_plotsTPR.C:1859
 Plot_plotsTPR.C:1860
 Plot_plotsTPR.C:1861
 Plot_plotsTPR.C:1862
 Plot_plotsTPR.C:1863
 Plot_plotsTPR.C:1864
 Plot_plotsTPR.C:1865
 Plot_plotsTPR.C:1866
 Plot_plotsTPR.C:1867
 Plot_plotsTPR.C:1868
 Plot_plotsTPR.C:1869
 Plot_plotsTPR.C:1870
 Plot_plotsTPR.C:1871
 Plot_plotsTPR.C:1872
 Plot_plotsTPR.C:1873
 Plot_plotsTPR.C:1874
 Plot_plotsTPR.C:1875
 Plot_plotsTPR.C:1876
 Plot_plotsTPR.C:1877
 Plot_plotsTPR.C:1878
 Plot_plotsTPR.C:1879
 Plot_plotsTPR.C:1880
 Plot_plotsTPR.C:1881
 Plot_plotsTPR.C:1882
 Plot_plotsTPR.C:1883
 Plot_plotsTPR.C:1884
 Plot_plotsTPR.C:1885
 Plot_plotsTPR.C:1886
 Plot_plotsTPR.C:1887
 Plot_plotsTPR.C:1888
 Plot_plotsTPR.C:1889
 Plot_plotsTPR.C:1890
 Plot_plotsTPR.C:1891
 Plot_plotsTPR.C:1892
 Plot_plotsTPR.C:1893
 Plot_plotsTPR.C:1894
 Plot_plotsTPR.C:1895
 Plot_plotsTPR.C:1896
 Plot_plotsTPR.C:1897
 Plot_plotsTPR.C:1898
 Plot_plotsTPR.C:1899
 Plot_plotsTPR.C:1900
 Plot_plotsTPR.C:1901
 Plot_plotsTPR.C:1902
 Plot_plotsTPR.C:1903
 Plot_plotsTPR.C:1904
 Plot_plotsTPR.C:1905
 Plot_plotsTPR.C:1906
 Plot_plotsTPR.C:1907
 Plot_plotsTPR.C:1908
 Plot_plotsTPR.C:1909
 Plot_plotsTPR.C:1910
 Plot_plotsTPR.C:1911
 Plot_plotsTPR.C:1912
 Plot_plotsTPR.C:1913
 Plot_plotsTPR.C:1914
 Plot_plotsTPR.C:1915
 Plot_plotsTPR.C:1916
 Plot_plotsTPR.C:1917
 Plot_plotsTPR.C:1918
 Plot_plotsTPR.C:1919
 Plot_plotsTPR.C:1920
 Plot_plotsTPR.C:1921
 Plot_plotsTPR.C:1922
 Plot_plotsTPR.C:1923
 Plot_plotsTPR.C:1924
 Plot_plotsTPR.C:1925
 Plot_plotsTPR.C:1926
 Plot_plotsTPR.C:1927
 Plot_plotsTPR.C:1928
 Plot_plotsTPR.C:1929
 Plot_plotsTPR.C:1930
 Plot_plotsTPR.C:1931
 Plot_plotsTPR.C:1932
 Plot_plotsTPR.C:1933
 Plot_plotsTPR.C:1934
 Plot_plotsTPR.C:1935
 Plot_plotsTPR.C:1936
 Plot_plotsTPR.C:1937
 Plot_plotsTPR.C:1938
 Plot_plotsTPR.C:1939
 Plot_plotsTPR.C:1940
 Plot_plotsTPR.C:1941
 Plot_plotsTPR.C:1942
 Plot_plotsTPR.C:1943
 Plot_plotsTPR.C:1944
 Plot_plotsTPR.C:1945
 Plot_plotsTPR.C:1946
 Plot_plotsTPR.C:1947
 Plot_plotsTPR.C:1948
 Plot_plotsTPR.C:1949
 Plot_plotsTPR.C:1950
 Plot_plotsTPR.C:1951
 Plot_plotsTPR.C:1952
 Plot_plotsTPR.C:1953
 Plot_plotsTPR.C:1954
 Plot_plotsTPR.C:1955
 Plot_plotsTPR.C:1956
 Plot_plotsTPR.C:1957
 Plot_plotsTPR.C:1958
 Plot_plotsTPR.C:1959
 Plot_plotsTPR.C:1960
 Plot_plotsTPR.C:1961
 Plot_plotsTPR.C:1962
 Plot_plotsTPR.C:1963
 Plot_plotsTPR.C:1964
 Plot_plotsTPR.C:1965
 Plot_plotsTPR.C:1966
 Plot_plotsTPR.C:1967
 Plot_plotsTPR.C:1968
 Plot_plotsTPR.C:1969
 Plot_plotsTPR.C:1970
 Plot_plotsTPR.C:1971
 Plot_plotsTPR.C:1972
 Plot_plotsTPR.C:1973
 Plot_plotsTPR.C:1974
 Plot_plotsTPR.C:1975
 Plot_plotsTPR.C:1976
 Plot_plotsTPR.C:1977
 Plot_plotsTPR.C:1978
 Plot_plotsTPR.C:1979
 Plot_plotsTPR.C:1980
 Plot_plotsTPR.C:1981
 Plot_plotsTPR.C:1982
 Plot_plotsTPR.C:1983
 Plot_plotsTPR.C:1984
 Plot_plotsTPR.C:1985
 Plot_plotsTPR.C:1986
 Plot_plotsTPR.C:1987
 Plot_plotsTPR.C:1988
 Plot_plotsTPR.C:1989
 Plot_plotsTPR.C:1990
 Plot_plotsTPR.C:1991
 Plot_plotsTPR.C:1992
 Plot_plotsTPR.C:1993
 Plot_plotsTPR.C:1994
 Plot_plotsTPR.C:1995
 Plot_plotsTPR.C:1996
 Plot_plotsTPR.C:1997
 Plot_plotsTPR.C:1998
 Plot_plotsTPR.C:1999
 Plot_plotsTPR.C:2000
 Plot_plotsTPR.C:2001
 Plot_plotsTPR.C:2002
 Plot_plotsTPR.C:2003
 Plot_plotsTPR.C:2004
 Plot_plotsTPR.C:2005
 Plot_plotsTPR.C:2006
 Plot_plotsTPR.C:2007
 Plot_plotsTPR.C:2008
 Plot_plotsTPR.C:2009
 Plot_plotsTPR.C:2010
 Plot_plotsTPR.C:2011
 Plot_plotsTPR.C:2012
 Plot_plotsTPR.C:2013
 Plot_plotsTPR.C:2014
 Plot_plotsTPR.C:2015
 Plot_plotsTPR.C:2016
 Plot_plotsTPR.C:2017
 Plot_plotsTPR.C:2018
 Plot_plotsTPR.C:2019
 Plot_plotsTPR.C:2020
 Plot_plotsTPR.C:2021
 Plot_plotsTPR.C:2022
 Plot_plotsTPR.C:2023
 Plot_plotsTPR.C:2024
 Plot_plotsTPR.C:2025
 Plot_plotsTPR.C:2026
 Plot_plotsTPR.C:2027
 Plot_plotsTPR.C:2028
 Plot_plotsTPR.C:2029
 Plot_plotsTPR.C:2030
 Plot_plotsTPR.C:2031
 Plot_plotsTPR.C:2032
 Plot_plotsTPR.C:2033
 Plot_plotsTPR.C:2034
 Plot_plotsTPR.C:2035
 Plot_plotsTPR.C:2036
 Plot_plotsTPR.C:2037
 Plot_plotsTPR.C:2038
 Plot_plotsTPR.C:2039
 Plot_plotsTPR.C:2040
 Plot_plotsTPR.C:2041
 Plot_plotsTPR.C:2042
 Plot_plotsTPR.C:2043
 Plot_plotsTPR.C:2044
 Plot_plotsTPR.C:2045
 Plot_plotsTPR.C:2046
 Plot_plotsTPR.C:2047
 Plot_plotsTPR.C:2048
 Plot_plotsTPR.C:2049
 Plot_plotsTPR.C:2050
 Plot_plotsTPR.C:2051
 Plot_plotsTPR.C:2052
 Plot_plotsTPR.C:2053
 Plot_plotsTPR.C:2054
 Plot_plotsTPR.C:2055
 Plot_plotsTPR.C:2056
 Plot_plotsTPR.C:2057
 Plot_plotsTPR.C:2058
 Plot_plotsTPR.C:2059
 Plot_plotsTPR.C:2060
 Plot_plotsTPR.C:2061
 Plot_plotsTPR.C:2062
 Plot_plotsTPR.C:2063
 Plot_plotsTPR.C:2064
 Plot_plotsTPR.C:2065
 Plot_plotsTPR.C:2066
 Plot_plotsTPR.C:2067
 Plot_plotsTPR.C:2068
 Plot_plotsTPR.C:2069
 Plot_plotsTPR.C:2070
 Plot_plotsTPR.C:2071
 Plot_plotsTPR.C:2072
 Plot_plotsTPR.C:2073
 Plot_plotsTPR.C:2074
 Plot_plotsTPR.C:2075
 Plot_plotsTPR.C:2076
 Plot_plotsTPR.C:2077
 Plot_plotsTPR.C:2078
 Plot_plotsTPR.C:2079
 Plot_plotsTPR.C:2080
 Plot_plotsTPR.C:2081
 Plot_plotsTPR.C:2082
 Plot_plotsTPR.C:2083
 Plot_plotsTPR.C:2084
 Plot_plotsTPR.C:2085
 Plot_plotsTPR.C:2086
 Plot_plotsTPR.C:2087
 Plot_plotsTPR.C:2088
 Plot_plotsTPR.C:2089
 Plot_plotsTPR.C:2090
 Plot_plotsTPR.C:2091
 Plot_plotsTPR.C:2092
 Plot_plotsTPR.C:2093
 Plot_plotsTPR.C:2094
 Plot_plotsTPR.C:2095
 Plot_plotsTPR.C:2096
 Plot_plotsTPR.C:2097
 Plot_plotsTPR.C:2098
 Plot_plotsTPR.C:2099
 Plot_plotsTPR.C:2100
 Plot_plotsTPR.C:2101
 Plot_plotsTPR.C:2102
 Plot_plotsTPR.C:2103
 Plot_plotsTPR.C:2104
 Plot_plotsTPR.C:2105
 Plot_plotsTPR.C:2106
 Plot_plotsTPR.C:2107
 Plot_plotsTPR.C:2108
 Plot_plotsTPR.C:2109
 Plot_plotsTPR.C:2110
 Plot_plotsTPR.C:2111
 Plot_plotsTPR.C:2112
 Plot_plotsTPR.C:2113
 Plot_plotsTPR.C:2114
 Plot_plotsTPR.C:2115
 Plot_plotsTPR.C:2116
 Plot_plotsTPR.C:2117
 Plot_plotsTPR.C:2118
 Plot_plotsTPR.C:2119
 Plot_plotsTPR.C:2120
 Plot_plotsTPR.C:2121
 Plot_plotsTPR.C:2122
 Plot_plotsTPR.C:2123
 Plot_plotsTPR.C:2124
 Plot_plotsTPR.C:2125
 Plot_plotsTPR.C:2126
 Plot_plotsTPR.C:2127
 Plot_plotsTPR.C:2128
 Plot_plotsTPR.C:2129
 Plot_plotsTPR.C:2130
 Plot_plotsTPR.C:2131
 Plot_plotsTPR.C:2132
 Plot_plotsTPR.C:2133
 Plot_plotsTPR.C:2134
 Plot_plotsTPR.C:2135
 Plot_plotsTPR.C:2136
 Plot_plotsTPR.C:2137
 Plot_plotsTPR.C:2138
 Plot_plotsTPR.C:2139
 Plot_plotsTPR.C:2140
 Plot_plotsTPR.C:2141
 Plot_plotsTPR.C:2142
 Plot_plotsTPR.C:2143
 Plot_plotsTPR.C:2144
 Plot_plotsTPR.C:2145
 Plot_plotsTPR.C:2146
 Plot_plotsTPR.C:2147
 Plot_plotsTPR.C:2148
 Plot_plotsTPR.C:2149
 Plot_plotsTPR.C:2150
 Plot_plotsTPR.C:2151
 Plot_plotsTPR.C:2152
 Plot_plotsTPR.C:2153
 Plot_plotsTPR.C:2154
 Plot_plotsTPR.C:2155
 Plot_plotsTPR.C:2156
 Plot_plotsTPR.C:2157
 Plot_plotsTPR.C:2158
 Plot_plotsTPR.C:2159
 Plot_plotsTPR.C:2160
 Plot_plotsTPR.C:2161
 Plot_plotsTPR.C:2162
 Plot_plotsTPR.C:2163
 Plot_plotsTPR.C:2164
 Plot_plotsTPR.C:2165
 Plot_plotsTPR.C:2166
 Plot_plotsTPR.C:2167
 Plot_plotsTPR.C:2168
 Plot_plotsTPR.C:2169
 Plot_plotsTPR.C:2170
 Plot_plotsTPR.C:2171
 Plot_plotsTPR.C:2172
 Plot_plotsTPR.C:2173
 Plot_plotsTPR.C:2174
 Plot_plotsTPR.C:2175
 Plot_plotsTPR.C:2176
 Plot_plotsTPR.C:2177
 Plot_plotsTPR.C:2178
 Plot_plotsTPR.C:2179
 Plot_plotsTPR.C:2180
 Plot_plotsTPR.C:2181
 Plot_plotsTPR.C:2182
 Plot_plotsTPR.C:2183
 Plot_plotsTPR.C:2184
 Plot_plotsTPR.C:2185
 Plot_plotsTPR.C:2186
 Plot_plotsTPR.C:2187
 Plot_plotsTPR.C:2188
 Plot_plotsTPR.C:2189
 Plot_plotsTPR.C:2190
 Plot_plotsTPR.C:2191
 Plot_plotsTPR.C:2192
 Plot_plotsTPR.C:2193
 Plot_plotsTPR.C:2194
 Plot_plotsTPR.C:2195
 Plot_plotsTPR.C:2196
 Plot_plotsTPR.C:2197
 Plot_plotsTPR.C:2198
 Plot_plotsTPR.C:2199
 Plot_plotsTPR.C:2200
 Plot_plotsTPR.C:2201
 Plot_plotsTPR.C:2202
 Plot_plotsTPR.C:2203
 Plot_plotsTPR.C:2204
 Plot_plotsTPR.C:2205
 Plot_plotsTPR.C:2206
 Plot_plotsTPR.C:2207
 Plot_plotsTPR.C:2208
 Plot_plotsTPR.C:2209
 Plot_plotsTPR.C:2210
 Plot_plotsTPR.C:2211
 Plot_plotsTPR.C:2212
 Plot_plotsTPR.C:2213
 Plot_plotsTPR.C:2214
 Plot_plotsTPR.C:2215
 Plot_plotsTPR.C:2216
 Plot_plotsTPR.C:2217
 Plot_plotsTPR.C:2218
 Plot_plotsTPR.C:2219
 Plot_plotsTPR.C:2220
 Plot_plotsTPR.C:2221
 Plot_plotsTPR.C:2222
 Plot_plotsTPR.C:2223
 Plot_plotsTPR.C:2224
 Plot_plotsTPR.C:2225
 Plot_plotsTPR.C:2226
 Plot_plotsTPR.C:2227
 Plot_plotsTPR.C:2228
 Plot_plotsTPR.C:2229
 Plot_plotsTPR.C:2230
 Plot_plotsTPR.C:2231
 Plot_plotsTPR.C:2232