96using std::numeric_limits, std::nothrow, std::map;
117 fFoamType(kSeparate),
124 fFillFoamWithOrigWeights(
kFALSE),
125 fDTSeparation(kFoam),
156 fFoamType(kSeparate),
163 fFillFoamWithOrigWeights(
kFALSE),
164 fDTSeparation(kFoam),
171 if(strlen(
name) > 128)
172 Log() << kFATAL <<
"Name too long " <<
name.Data() <<
Endl;
184 delete fVariableNames;
186 if (fDistr)
delete fDistr;
187 if (fPseRan)
delete fPseRan;
188 if (fXmin) {
delete [] fXmin; fXmin=0; }
189 if (fXmax) {
delete [] fXmax; fXmax=0; }
193 for(
Int_t i=0; i<fNCells; i++)
delete fCells[i];
223 , fFoamType(kSeparate)
230 , fFillFoamWithOrigWeights(
kFALSE)
231 , fDTSeparation(kFoam)
238 Log() << kFATAL <<
"COPY CONSTRUCTOR NOT IMPLEMENTED" <<
Endl;
251 Log() << kFATAL <<
"<SetDim>: Dimension is zero or negative!" <<
Endl;
254 if (fXmin)
delete [] fXmin;
255 if (fXmax)
delete [] fXmax;
265 if (idim<0 || idim>=GetTotDim())
266 Log() << kFATAL <<
"<SetXmin>: Dimension out of bounds!" <<
Endl;
276 if (idim<0 || idim>=GetTotDim())
277 Log() << kFATAL <<
"<SetXmax>: Dimension out of bounds!" <<
Endl;
295 if(fPseRan==0) Log() << kFATAL <<
"Random number generator not set" <<
Endl;
296 if(fDistr==0) Log() << kFATAL <<
"Distribution function not set" <<
Endl;
297 if(fDim==0) Log() << kFATAL <<
"Zero dimension not allowed" <<
Endl;
304 if(fRvec==0) Log() << kFATAL <<
"Cannot initialize buffer fRvec" <<
Endl;
308 if(fAlpha==0) Log() << kFATAL <<
"Cannot initialize buffer fAlpha" <<
Endl;
313 fInhiDiv =
new Int_t[fDim];
314 for(
Int_t i=0; i<fDim; i++) fInhiDiv[i]=0;
318 fMaskDiv =
new Int_t[fDim];
319 for(
Int_t i=0; i<fDim; i++) fMaskDiv[i]=1;
323 for(
Int_t i=0; i<fDim; i++){
325 hname = fName+
TString(
"_HistEdge_");
327 htitle =
TString(
"Edge Histogram No. ");
329 (*fHistEdg)[i] =
new TH1D(hname.
Data(),htitle.
Data(),fNBin,0.0, 1.0);
330 ((
TH1D*)(*fHistEdg)[i])->Sumw2();
358 for(
Int_t i=0; i<fNCells; i++)
delete fCells[i];
364 Log() << kFATAL <<
"not enough memory to create " << fNCells
367 for(
Int_t i=0; i<fNCells; i++){
369 fCells[i]->SetSerial(i);
378 for(
Long_t iCell=0; iCell<=fLastCe; iCell++){
379 Explore( fCells[iCell] );
390 if (fLastCe==fNCells){
391 Log() << kFATAL <<
"Too many cells" <<
Endl;
395 cell = fCells[fLastCe];
397 cell->
Fill(status, parent, 0, 0);
450 cell->
GetHcub(cellPosi,cellSize);
460 for (
Int_t idim = 0; idim < fDim; ++idim)
461 vol_scale *= fXmax[idim] - fXmin[idim];
467 toteventsOld = GetCellElement(cell, 0);
478 for (i=0;i<fDim;i++) ((
TH1D *)(*fHistEdg)[i])->Reset();
482 for (iev=0;iev<fNSampl;iev++){
485 if (fDim>0)
for (j=0; j<fDim; j++) xRand[j]= cellPosi[j] +fAlpha[j]*(cellSize[j]);
487 wt = dx*Eval(xRand, event_density);
488 totevents += event_density;
492 for (k=0; k<fDim; k++) {
494 ((
TH1D *)(*fHistEdg)[nProj])->Fill(xproj,wt);
502 if (ceSum[3]>wt) ceSum[3]=wt;
503 if (ceSum[4]<wt) ceSum[4]=wt;
505 if (ceSum[1]>0) nevEff = ceSum[0]*ceSum[0]/ceSum[1];
507 if ( nevEff >= fNBin*fEvPerBin)
break;
511 if (fNSampl>0) totevents /= fNSampl;
515 if (cell==fCells[0] && ceSum[0]<=0.0){
517 Log() << kFATAL <<
"No events were found during exploration of "
518 <<
"root cell. Please check PDEFoam parameters nSampl "
519 <<
"and VolFrac." <<
Endl;
521 Log() << kWARNING <<
"Negative number of events found during "
522 <<
"exploration of root cell" <<
Endl;
527 for (k=0; k<fDim;k++){
529 if ( fInhiDiv[k]==1) fMaskDiv[k] =0;
536 Double_t intTrue = ceSum[0]/(nevMC+0.000001);
539 if (kBest == -1) Varedu(ceSum,kBest,xBest,yBest);
540 intDriv =sqrt(ceSum[1]/nevMC) -intTrue;
547 SetCellElement(cell, 0, totevents);
551 for (parent = cell->
GetPare(); parent!=0; parent = parent->
GetPare()){
554 parent->
SetIntg( parIntg +intTrue -intOld );
555 parent->
SetDriv( parDriv +intDriv -driOld );
556 SetCellElement( parent, 0, GetCellElement(parent, 0) + totevents - toteventsOld);
573 Double_t ssw = sqrt(sswAll)/sqrt(nent);
581 for(
Int_t kProj=0; kProj<fDim; kProj++) {
582 if( fMaskDiv[kProj]) {
589 for(
Int_t jLo=1; jLo<=fNBin; jLo++) {
592 for(
Int_t jUp=jLo; jUp<=fNBin;jUp++) {
594 asswIn += Sqr(((
TH1D *)(*fHistEdg)[kProj])->GetBinError( jUp));
599 if ( (xUp-xLo) < std::numeric_limits<double>::epsilon()) sswIn=0.;
600 else sswIn = sqrt(asswIn) /sqrt(nent*(xUp-xLo)) *(xUp-xLo);
601 if ( (1.0-xUp+xLo) < std::numeric_limits<double>::epsilon()) sswOut=0.;
602 else if ( sswAll-asswIn < std::numeric_limits<double>::epsilon()) sswOut=0.;
603 else sswOut= sqrt(sswAll-asswIn)/sqrt(nent*(1.0-xUp+xLo)) *(1.0-xUp+xLo);
604 if( (sswIn+sswOut) < sswtBest) {
605 sswtBest = sswIn+sswOut;
622 if(iLo == 0) xBest=yBest;
623 if(iUp == fNBin) yBest=xBest;
628 if( (kBest >= fDim) || (kBest<0) )
629 Log() << kFATAL <<
"Something wrong with kBest" <<
Endl;
639 fPseRan->RndmArray(fDim,fRvec);
640 for(
Int_t k=0; k<fDim; k++) fAlpha[k] = fRvec[k];
660 for(i=0; i<=fLastCe; i++) {
661 if( fCells[i]->GetStat() == 1 ) {
663 driv = fCells[i]->GetDriv();
664 if (driv < std::numeric_limits<float>::epsilon())
669 if (xDiv <= std::numeric_limits<Double_t>::epsilon() ||
670 xDiv >= 1.0 - std::numeric_limits<Double_t>::epsilon())
674 if (GetMaxDepth() > 0)
675 bCutMaxDepth = fCells[i]->GetDepth() < GetMaxDepth();
679 bCutNmin = GetCellElement(fCells[i], 0) > GetNmin();
682 if(driv > drivMax && bCutNmin && bCutMaxDepth) {
691 Log() << kVERBOSE <<
"Warning: No cell with more than "
692 << GetNmin() <<
" events found!" <<
Endl;
693 else if (!bCutMaxDepth)
694 Log() << kVERBOSE <<
"Warning: Maximum depth reached: "
695 << GetMaxDepth() <<
Endl;
697 Log() << kWARNING <<
"<PDEFoam::PeekMax>: no more candidate cells (drivMax>0) found for further splitting." <<
Endl;
718 if(fLastCe+1 >= fNCells) Log() << kFATAL <<
"Buffer limit is reached, fLastCe=fnBuf" <<
Endl;
725 if( kBest<0 || kBest>=fDim ) Log() << kFATAL <<
"Wrong kBest" <<
Endl;
731 Int_t d1 = CellFill(1, cell);
732 Int_t d2 = CellFill(1, cell);
736 Explore( (fCells[d1]) );
737 Explore( (fCells[d2]) );
752 std::vector<Double_t> xvec;
753 xvec.reserve(GetTotDim());
754 for (
Int_t idim = 0; idim < GetTotDim(); ++idim)
755 xvec.push_back( VarTransformInvers(idim, xRand[idim]) );
757 return GetDistr()->Density(xvec, event_density);
768 fTimer->Init(fNCells);
773 while ( (fLastCe+2) < fNCells ) {
776 if ( (iCell<0) || (iCell>fLastCe) ) {
777 Log() << kVERBOSE <<
"Break: "<< fLastCe+1 <<
" cells created" <<
Endl;
779 for (
Long_t jCell=fLastCe+1; jCell<fNCells; jCell++)
780 delete fCells[jCell];
784 newCell = fCells[iCell];
788 if ( Divide( newCell )==0)
break;
793 Log() << kVERBOSE << GetNActiveCells() <<
" active cells created" <<
Endl;
803 if(fDim==0) Log() << kFATAL <<
"SetInhiDiv: fDim=0" <<
Endl;
805 fInhiDiv =
new Int_t[ fDim ];
806 for(
Int_t i=0; i<fDim; i++) fInhiDiv[i]=0;
809 if( ( 0<=iDim) && (iDim<fDim)) {
810 fInhiDiv[iDim] = inhiDiv;
812 Log() << kFATAL <<
"Wrong iDim" <<
Endl;
823 Int_t errors, warnings;
827 errors = 0; warnings = 0;
828 if (level==1) Log() << kVERBOSE <<
"Performing consistency checks for created foam" <<
Endl;
829 for(iCell=1; iCell<=fLastCe; iCell++) {
830 cell = fCells[iCell];
835 if (level==1) Log() << kFATAL <<
"ERROR: Cell's no %d has only one daughter " << iCell <<
Endl;
839 if (level==1) Log() << kFATAL <<
"ERROR: Cell's no %d has no daughter and is inactive " << iCell <<
Endl;
843 if (level==1) Log() << kFATAL <<
"ERROR: Cell's no %d has two daughters and is active " << iCell <<
Endl;
847 if( (cell->
GetPare())!=fCells[0] ) {
850 if (level==1) Log() << kFATAL <<
"ERROR: Cell's no %d parent not pointing to this cell " << iCell <<
Endl;
858 if (level==1) Log() << kFATAL <<
"ERROR: Cell's no %d daughter 0 not pointing to this cell " << iCell <<
Endl;
864 if (level==1) Log() << kFATAL <<
"ERROR: Cell's no %d daughter 1 not pointing to this cell " << iCell <<
Endl;
869 if(level==1) Log() << kFATAL <<
"ERROR: Cell no. " << iCell <<
" has Volume of <1E-50" <<
Endl;
874 for(iCell=0; iCell<=fLastCe; iCell++) {
875 cell = fCells[iCell];
878 if(level==1) Log() << kFATAL <<
"ERROR: Cell no. " << iCell <<
" is active but Volume is 0 " <<
Endl;
883 Log() << kVERBOSE <<
"Check has found " << errors <<
" errors and " << warnings <<
" warnings." <<
Endl;
886 Info(
"CheckAll",
"Check - found total %d errors \n",errors);
896 if (iCell < 0 || iCell > fLastCe) {
897 Log() << kWARNING <<
"<PrintCell(iCell=" << iCell
898 <<
")>: cell number " << iCell <<
" out of bounds!"
904 fCells[iCell]->GetHcub(cellPosi,cellSize);
905 Int_t kBest = fCells[iCell]->GetBest();
906 Double_t xBest = fCells[iCell]->GetXdiv();
908 Log() <<
"Cell[" << iCell <<
"]={ ";
909 Log() <<
" " << fCells[iCell] <<
" " <<
Endl;
910 Log() <<
" Xdiv[abs. coord.]="
911 << VarTransformInvers(kBest,cellPosi[kBest] + xBest*cellSize[kBest])
913 Log() <<
" Abs. coord. = (";
914 for (
Int_t idim=0; idim<fDim; idim++) {
915 Log() <<
"dim[" << idim <<
"]={"
916 << VarTransformInvers(idim,cellPosi[idim]) <<
","
917 << VarTransformInvers(idim,cellPosi[idim] + cellSize[idim])
922 Log() <<
")" <<
Endl;
923 fCells[iCell]->
Print(
"1");
925 Log() <<
"Elements: [";
928 for (
Int_t i=0; i<
vec->GetNrows(); i++){
929 if (i>0) Log() <<
", ";
930 Log() << GetCellElement(fCells[iCell], i);
934 Log() <<
"]" <<
Endl;
943 for(
Long_t iCell=0; iCell<=fLastCe; iCell++)
957 std::vector<Float_t> values = ev->
GetValues();
958 std::vector<Float_t> tvalues = VarTransform(values);
963 SetCellElement(cell, 0, GetCellElement(cell, 0) + wt);
964 SetCellElement(cell, 1, GetCellElement(cell, 1) + wt*wt);
974 Log() << kVERBOSE <<
"Delete cell elements" <<
Endl;
975 for (
Long_t iCell = 0; iCell < fNCells; ++iCell) {
976 TObject* elements = fCells[iCell]->GetElement();
979 fCells[iCell]->SetElement(NULL);
1017 std::vector<Float_t> txvec(VarTransform(xvec));
1019 return GetCellValue(FindCell(txvec), cv);
1021 return kernel->
Estimate(
this, txvec, cv);
1045 std::map<Int_t,Float_t> txvec;
1046 for (std::map<Int_t,Float_t>::const_iterator it=xvec.begin(); it!=xvec.end(); ++it)
1047 txvec.insert(std::pair<Int_t, Float_t>(it->first, VarTransform(it->first, it->second)));
1050 std::vector<PDEFoamCell*> cells = FindCells(txvec);
1053 std::vector<Float_t> cell_values;
1054 cell_values.reserve(cells.size());
1055 for (std::vector<PDEFoamCell*>::const_iterator cell_it=cells.begin();
1056 cell_it != cells.end(); ++cell_it)
1057 cell_values.push_back(GetCellValue(*cell_it, cv));
1081 PDEFoamVect cellPosi0(GetTotDim()), cellSize0(GetTotDim());
1089 cell0->
GetHcub(cellPosi0,cellSize0);
1091 if (xvec.at(idim)<=cellPosi0[idim]+cellSize0[idim])
1119 PDEFoamVect cellPosi0(GetTotDim()), cellSize0(GetTotDim());
1127 map<Int_t, Float_t>::const_iterator it = txvec.find(idim);
1129 if (it != txvec.end()){
1133 cell0->
GetHcub(cellPosi0,cellSize0);
1135 if (it->second <= cellPosi0[idim] + cellSize0[idim])
1141 FindCells(txvec, cell->
GetDau0(), cells);
1142 FindCells(txvec, cell->
GetDau1(), cells);
1146 cells.push_back(cell);
1167 std::map<Int_t, Float_t> txvec_map;
1168 for (
UInt_t i=0; i<txvec.size(); ++i)
1169 txvec_map.insert(std::pair<Int_t, Float_t>(i, txvec.at(i)));
1172 std::vector<PDEFoamCell*> cells(0);
1175 FindCells(txvec_map, fCells[0], cells);
1198 std::vector<PDEFoamCell*> cells(0);
1201 FindCells(txvec, fCells[0], cells);
1220 if ( GetTotDim()!=1 )
1221 Log() << kFATAL <<
"<Draw1Dim>: function can only be used for 1-dimensional foams!"
1227 h1=
new TH1D(hname,
"1-dimensional Foam", nbin, fXmin[0], fXmax[0]);
1229 if (!
h1) Log() << kFATAL <<
"ERROR: Can not create histo" << hname <<
Endl;
1234 std::vector<Float_t> txvec;
1237 if (kernel != NULL) {
1239 val = kernel->
Estimate(
this, txvec, cell_value);
1241 val = GetCellValue(FindCell(txvec), cell_value);
1272 if ((idim1>=GetTotDim()) || (idim1<0) ||
1273 (idim2>=GetTotDim()) || (idim2<0) ||
1275 Log() << kFATAL <<
"<Project2>: wrong dimensions given: "
1276 << idim1 <<
", " << idim2 <<
Endl;
1282 Log() << kWARNING <<
"Warning: number of bins too big: " << nbin
1283 <<
" Using 1000 bins for each dimension instead." <<
Endl;
1285 }
else if (nbin<1) {
1286 Log() << kWARNING <<
"Wrong bin number: " << nbin
1287 <<
"; set nbin=50" <<
Endl;
1297 h1 =
new TH2D(hname.
Data(),
TString::Format(
"var%d vs var%d",idim1,idim2).
Data(), nbin, fXmin[idim1], fXmax[idim1], nbin, fXmin[idim2], fXmax[idim2]);
1299 if (!
h1) Log() << kFATAL <<
"ERROR: Can not create histo" << hname <<
Endl;
1307 std::map<Int_t, Float_t> txvec;
1313 std::vector<TMVA::PDEFoamCell*> cells = FindCells(txvec);
1318 for (std::vector<TMVA::PDEFoamCell*>::const_iterator it = cells.begin();
1319 it != cells.end(); ++it) {
1321 PDEFoamVect cellPosi(GetTotDim()), cellSize(GetTotDim());
1322 (*it)->GetHcub(cellPosi,cellSize);
1325 std::vector<Float_t> tvec;
1326 for (
Int_t i=0; i<GetTotDim(); ++i) {
1327 if ( i != idim1 && i != idim2 )
1328 tvec.push_back(cellPosi[i] + 0.5*cellSize[i]);
1330 tvec.push_back(txvec[i]);
1332 if (kernel != NULL) {
1334 sum_cv += kernel->
Estimate(
this, tvec, cell_value);
1336 sum_cv += GetCellValue(FindCell(tvec), cell_value);
1361 return GetCellElement(cell, 0);
1364 return GetCellElement(cell, 1);
1366 case kValueDensity: {
1369 if (volume > numeric_limits<double>::epsilon()) {
1370 return GetCellValue(cell, kValue)/volume;
1374 Log() << kWARNING <<
"<GetCellDensity(cell)>: ERROR: cell volume"
1375 <<
" negative or zero!"
1376 <<
" ==> return cell density 0!"
1377 <<
" cell volume=" << volume
1378 <<
" cell entries=" << GetCellValue(cell, kValue) <<
Endl;
1380 Log() << kWARNING <<
"<GetCellDensity(cell)>: WARNING: cell volume"
1381 <<
" close to zero!"
1382 <<
" cell volume: " << volume <<
Endl;
1404 Log() << kFATAL <<
"<GetCellValue>: unknown cell value" <<
Endl;
1446 Log() << kFATAL <<
"<SetCellElement> ERROR: cell element is not a TVectorD*" <<
Endl;
1462 Log() << kINFO <<
"Elapsed time: " + fTimer->GetElapsedTime()
1469 if (fNCells >= 100) modulo =
Int_t(fNCells/100);
1470 if (fLastCe%modulo == 0) fTimer->DrawProgressBar( fLastCe );
1513 if (GetTotDim() != 2)
1514 Log() << kFATAL <<
"RootPlot2dim() can only be used with "
1515 <<
"two-dimensional foams!" <<
Endl;
1518 ECellValue cell_value = kValue;
1522 cell_value = kValue;
1523 }
else if (opt.
Contains(
"rms_ov_mean")){
1524 cell_value = kRmsOvMean;
1531 plotcellnumber =
kTRUE;
1534 std::ofstream outfile(
filename, std::ios::out);
1536 outfile<<
"{" << std::endl;
1541 outfile <<
"TColor *graycolors[100];" << std::endl;
1542 outfile <<
"for (Int_t i=0.; i<100; i++)" << std::endl;
1543 outfile <<
" graycolors[i]=new TColor(1000+i, 1-(Float_t)i/100.,1-(Float_t)i/100.,1-(Float_t)i/100.);"<< std::endl;
1546 outfile <<
"cMap = new TCanvas(\"" << fName <<
"\",\"Cell Map for "
1547 << fName <<
"\",600,600);" << std::endl;
1549 outfile<<
"TBox*a=new TBox();"<<std::endl;
1550 outfile<<
"a->SetFillStyle(0);"<<std::endl;
1551 outfile<<
"a->SetLineWidth(4);"<<std::endl;
1552 outfile<<
"TBox *b1=new TBox();"<<std::endl;
1553 outfile<<
"TText*t=new TText();"<<std::endl;
1555 outfile << (
colors ?
"gStyle->SetPalette(1, 0);" :
"gStyle->SetPalette(0);")
1557 outfile <<
"b1->SetFillStyle(1001);"<<std::endl;
1558 outfile<<
"TBox *b2=new TBox();"<<std::endl;
1559 outfile <<
"b2->SetFillStyle(0);"<<std::endl;
1562 outfile <<
"b1->SetFillStyle(0);"<<std::endl;
1574 for (
Long_t iCell=1; iCell<=fLastCe; iCell++) {
1575 if ( fCells[iCell]->GetStat() == 1) {
1576 Float_t value = GetCellValue(fCells[iCell], cell_value);
1583 outfile <<
"// observed minimum and maximum of distribution: " << std::endl;
1584 outfile <<
"// Float_t zmin = "<< zmin <<
";" << std::endl;
1585 outfile <<
"// Float_t zmax = "<< zmax <<
";" << std::endl;
1588 outfile <<
"// used minimum and maximum of distribution (taking into account log scale if applicable): " << std::endl;
1589 outfile <<
"Float_t zmin = "<< zmin <<
";" << std::endl;
1590 outfile <<
"Float_t zmax = "<< zmax <<
";" << std::endl;
1596 Float_t scale = (ncolors-1)/(zmax - zmin);
1597 PDEFoamVect cellPosi(GetTotDim()), cellSize(GetTotDim());
1601 outfile <<
"// =========== Rectangular cells ==========="<< std::endl;
1602 for (
Long_t iCell=1; iCell<=fLastCe; iCell++) {
1603 if ( fCells[iCell]->GetStat() == 1) {
1604 fCells[iCell]->GetHcub(cellPosi,cellSize);
1605 x1 = offs+lpag*(cellPosi[0]);
1606 y1 = offs+lpag*(cellPosi[1]);
1607 x2 = offs+lpag*(cellPosi[0]+cellSize[0]);
1608 y2 = offs+lpag*(cellPosi[1]+cellSize[1]);
1612 Float_t value = GetCellValue(fCells[iCell], cell_value);
1622 outfile <<
"b1->SetFillColor(" << color <<
");" << std::endl;
1626 outfile<<
"b1->DrawBox("<<
x1<<
","<<
y1<<
","<<
x2<<
","<<
y2<<
");"<<std::endl;
1628 outfile<<
"b2->DrawBox("<<
x1<<
","<<
y1<<
","<<
x2<<
","<<
y2<<
");"<<std::endl;
1631 if (plotcellnumber) {
1632 outfile<<
"t->SetTextColor(4);"<<std::endl;
1634 outfile<<
"t->SetTextSize(0.025);"<<std::endl;
1635 else if(fLastCe<251)
1636 outfile<<
"t->SetTextSize(0.015);"<<std::endl;
1638 outfile<<
"t->SetTextSize(0.008);"<<std::endl;
1639 x = offs+lpag*(cellPosi[0]+0.5*cellSize[0]);
1640 y = offs+lpag*(cellPosi[1]+0.5*cellSize[1]);
1641 outfile<<
"t->DrawText("<<
x<<
","<<
y<<
","<<
"\""<<iCell<<
"\""<<
");"<<std::endl;
1645 outfile<<
"// ============== End Rectangles ==========="<< std::endl;
1647 outfile <<
"}" << std::endl;
1658 GetDistr()->FillBinarySearchTree(ev);
1667 if(fDistr)
delete fDistr;
static const Float_t kVlow
static const Float_t kHigh
void Info(const char *location, const char *msgfmt,...)
Use this function for informational messages.
Option_t Option_t TPoint TPoint const char GetTextMagnitude GetFillStyle GetLineColor GetLineWidth GetMarkerStyle GetTextAlign GetTextColor GetTextSize void char Point_t Rectangle_t WindowAttributes_t Float_t Float_t Float_t Int_t Int_t UInt_t UInt_t Rectangle_t Int_t Int_t Window_t TString Int_t GCValues_t GetPrimarySelectionOwner GetDisplay GetScreen GetColormap GetNativeEvent const char const char dpyName wid window const char font_name cursor keysym reg const char only_if_exist regb h Point_t winding char text const char depth char const char Int_t count const char ColorStruct_t color const char filename
Option_t Option_t TPoint TPoint const char GetTextMagnitude GetFillStyle GetLineColor GetLineWidth GetMarkerStyle GetTextAlign GetTextColor GetTextSize void char Point_t Rectangle_t wmin
Option_t Option_t TPoint TPoint const char GetTextMagnitude GetFillStyle GetLineColor GetLineWidth GetMarkerStyle GetTextAlign GetTextColor GetTextSize void value
Option_t Option_t TPoint TPoint const char x2
Option_t Option_t TPoint TPoint const char x1
Option_t Option_t TPoint TPoint const char y2
Option_t Option_t TPoint TPoint const char GetTextMagnitude GetFillStyle GetLineColor GetLineWidth GetMarkerStyle GetTextAlign GetTextColor GetTextSize void char Point_t Rectangle_t wmax
Option_t Option_t TPoint TPoint const char y1
R__EXTERN TStyle * gStyle
TVectorT< Double_t > TVectorD
virtual Double_t GetBinCenter(Int_t bin) const
Return center of bin.
virtual void SetOwner(Bool_t enable=kTRUE)
Set whether this collection is the owner (enable==true) of its content.
1-D histogram with a double per channel (see TH1 documentation)
virtual Double_t GetBinCenter(Int_t bin) const
Return bin center for 1D histogram.
virtual Int_t GetNbinsY() const
static void AddDirectory(Bool_t add=kTRUE)
Sets the flag controlling the automatic add of histograms in memory.
virtual Int_t GetNbinsX() const
virtual void SetBinContent(Int_t bin, Double_t content)
Set bin content see convention for numbering bins in TH1::GetBin In case the bin number is greater th...
virtual Double_t GetBinContent(Int_t bin) const
Return content of bin number bin.
static Bool_t AddDirectoryStatus()
Static function: cannot be inlined on Windows/NT.
2-D histogram with a double per channel (see TH1 documentation)
std::vector< Float_t > & GetValues()
ostringstream derivative to redirect and format output
void Fill(Int_t, PDEFoamCell *, PDEFoamCell *, PDEFoamCell *)
Fills in certain data into newly allocated cell.
void SetDau0(PDEFoamCell *Daug)
void SetXdiv(Double_t Xdiv)
void Print(Option_t *option) const
Printout of the cell geometry parameters for the debug purpose.
void SetElement(TObject *fobj)
void CalcVolume()
Calculates volume of the cell using size params which are calculated.
PDEFoamCell * GetPare() const
PDEFoamCell * GetDau1() const
PDEFoamCell * GetDau0() const
void SetDau1(PDEFoamCell *Daug)
Double_t GetVolume() const
TObject * GetElement() const
void SetDriv(Double_t Driv)
void GetHcub(PDEFoamVect &, PDEFoamVect &) const
Provides size and position of the cell These parameter are calculated by analyzing information in all...
void SetIntg(Double_t Intg)
This class is the abstract kernel interface for PDEFoam.
virtual Float_t Estimate(PDEFoam *, std::vector< Float_t > &, ECellValue)=0
Implementation of PDEFoam.
Double_t GetCellElement(const PDEFoamCell *cell, UInt_t i) const
Returns cell element i of cell 'cell'.
void DeleteBinarySearchTree()
Delete the foam's density estimator, which contains the binary search tree.
void MakeAlpha()
Internal subprogram used by Create.
TObjArray * fVariableNames
collection of all variable names
virtual Float_t GetCellValue(const std::vector< Float_t > &xvec, ECellValue cv, PDEFoamKernelBase *)
This function finds the cell, which corresponds to the given untransformed event vector 'xvec' and re...
void OutputGrow(Bool_t finished=false)
Overridden function of PDEFoam to avoid native foam output.
void SetCellElement(PDEFoamCell *cell, UInt_t i, Double_t value)
Set cell element i of cell to value.
Int_t Divide(PDEFoamCell *)
Internal subprogram used by Create.
void PrintCell(Long_t iCell=0)
Prints geometry of and elements of 'iCell', as well as relations to parent and daughter cells.
void ResetCellElements()
Remove the cell elements from all cells.
void Grow()
Internal subprogram used by Create.
TH1D * Draw1Dim(ECellValue cell_value, Int_t nbin, PDEFoamKernelBase *kernel=nullptr)
Draws 1-dimensional foam (= histogram)
Double_t Eval(Double_t *xRand, Double_t &event_density)
Internal subprogram.
void PrintCells()
Prints geometry of ALL cells of the FOAM.
void SetXmax(Int_t idim, Double_t wmax)
set upper foam bound in dimension idim
virtual ~PDEFoam()
Default destructor.
PDEFoam()
Default constructor for streamer, user should not use it.
virtual TH2D * Project2(Int_t idim1, Int_t idim2, ECellValue cell_value=kValue, PDEFoamKernelBase *kernel=nullptr, UInt_t nbin=50)
Project foam variable idim1 and variable idim2 to histogram.
virtual Bool_t CellValueIsUndefined(PDEFoamCell *)
Returns true, if the value of the given cell is undefined.
virtual void FillFoamCells(const Event *ev, Float_t wt)
This function fills a weight 'wt' into the PDEFoam cell, which corresponds to the given event 'ev'.
void Create()
Basic initialization of FOAM invoked by the user.
void SetInhiDiv(Int_t, Int_t)
This can be called before Create, after setting kDim It defines which variables are excluded in the p...
void InitCells()
Internal subprogram used by Create.
PDEFoamCell * FindCell(const std::vector< Float_t > &) const
Find cell that contains 'xvec' (in foam coordinates [0,1]).
void FillBinarySearchTree(const Event *ev)
Insert event to internal foam's density estimator PDEFoamDensityBase.
virtual void Explore(PDEFoamCell *Cell)
Internal subprogram used by Create.
void SetXmin(Int_t idim, Double_t wmin)
set lower foam bound in dimension idim
std::vector< TMVA::PDEFoamCell * > FindCells(const std::vector< Float_t > &) const
Find all cells, that contain txvec.
void Varedu(Double_t[5], Int_t &, Double_t &, Double_t &)
Internal subprogram used by Create.
Int_t CellFill(Int_t, PDEFoamCell *)
Internal subprogram used by Create.
Long_t PeekMax()
Internal subprogram used by Create.
void RootPlot2dim(const TString &filename, TString opt, Bool_t createCanvas=kTRUE, Bool_t colors=kTRUE)
Debugging tool which plots the cells of a 2-dimensional PDEFoam as rectangles in C++ format readable ...
void CheckAll(Int_t)
User utility, miscellaneous and debug.
void SetDim(Int_t kDim)
Sets dimension of cubical space.
Timing information for training and evaluation of MVA methods.
Mother of all ROOT objects.
virtual void Print(Option_t *option="") const
This method must be overridden when a class wants to print itself.
Random number generator class based on M.
const char * Data() const
static TString Format(const char *fmt,...)
Static method which formats a string using a printf style format descriptor and return a TString.
Bool_t Contains(const char *pat, ECaseCompare cmp=kExact) const
void SetPalette(Int_t ncolors=kBird, Int_t *colors=nullptr, Float_t alpha=1.)
See TColor::SetPalette.
Int_t GetColorPalette(Int_t i) const
Return color number i in current palette.
Int_t GetNumberOfColors() const
Return number of colors in the color palette.
MsgLogger & Endl(MsgLogger &ml)
Short_t Abs(Short_t d)
Returns the absolute value of parameter Short_t d.