]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - STAT/TKDInterpolatorBase.cxx
reduce size on disk for storing PDF nodes
[u/mrichter/AliRoot.git] / STAT / TKDInterpolatorBase.cxx
index 2afcf08b24df288abfd98504d7fa7e871773ba16..ff847c9c694268fbf5b6cc7d4f79c5f8f750d71f 100644 (file)
@@ -2,16 +2,13 @@
 #include "TKDNodeInfo.h"
 #include "TKDTree.h"
 
-#include "TRandom.h"
+#include "TROOT.h"
 #include "TClonesArray.h"
 #include "TLinearFitter.h"
 #include "TTree.h"
 #include "TH2.h"
 #include "TObjArray.h"
 #include "TObjString.h"
-#include "TBox.h"
-#include "TGraph.h"
-#include "TMarker.h"
 #include "TMath.h"
 #include "TVectorD.h"
 #include "TMatrixD.h"
@@ -33,34 +30,63 @@ ClassImp(TKDInterpolatorBase)
 //_________________________________________________________________
 TKDInterpolatorBase::TKDInterpolatorBase(Int_t dim) :
   fNSize(dim)
-  ,fNTNodes(0)
-  ,fTNodes(0x0)
-  ,fStatus(4)
+  ,fNodes(NULL)
+  ,fNodesDraw(NULL)
+  ,fStatus(0)
   ,fLambda(1 + dim + (dim*(dim+1)>>1))
   ,fDepth(-1)
   ,fAlpha(.5)
-  ,fRefPoints(0x0)
-  ,fBuffer(0x0)
-  ,fKDhelper(0x0)
-  ,fFitter(0x0)
+  ,fRefPoints(NULL)
+  ,fBuffer(NULL)
+  ,fKDhelper(NULL)
+  ,fFitter(NULL)
 {
 // Default constructor. To be used with care since in this case building
 // of data structure is completly left to the user responsability.
+  UseWeights();
 }
 
 //_________________________________________________________________
-void   TKDInterpolatorBase::Build(Int_t n)
+Bool_t TKDInterpolatorBase::Build(Int_t n)
 {
   // allocate memory for data
+  if(Int_t((1.+fAlpha)*fLambda) > n){ // check granularity
+    Error("TKDInterpolatorBase::Build()", Form("Minimum number of points [%d] needed for interpolation exceeds number of evaluation points [%d]. Please increase granularity.", Int_t((1.+fAlpha)*fLambda), n));
+    return kFALSE;
+  }
+
+  if(fNodes){
+    Warning("TKDInterpolatorBase::Build()", "Data already allocated.");
+    fNodes->Delete();
+  } else {
+    fNodes = new TClonesArray("TKDNodeInfo", n); 
+    fNodes->SetOwner();
+  }
+
+  for(int in=0; in<n; in++) new ((*fNodes)[in]) TKDNodeInfo(fNSize);
 
-  if(fTNodes) delete fTNodes;
-  fNTNodes = n;
-  // check granularity
-  if(Int_t((1.+fAlpha)*fLambda) > fNTNodes){
-    Warning("TKDInterpolatorBase::Build()", Form("Minimum number of points [%d] needed for interpolation exceeds number of evaluation points [%d]. Please increase granularity.", Int_t((1.+fAlpha)*fLambda), fNTNodes));
+  return kTRUE;
+}
+
+//_________________________________________________________________
+Bool_t TKDInterpolatorBase::Bootstrap()
+{
+  if(!fNodes){
+    Error("TKDInterpolatorBase::Bootstrap()", "Nodes missing. Nothing to bootstrap from.");
+    return kFALSE;
+  }
+  Int_t in = GetNTNodes(); TKDNodeInfo *n(NULL);
+  while(in--){ 
+    if(!(n=(TKDNodeInfo*)(*fNodes)[in])){
+      Error("TKDInterpolatorBase::Bootstrap()", Form("Node @ %d missing.", in));
+      return kFALSE;
+    }
+    n->Bootstrap();
+    if(!fNSize) fNSize  = n->GetDimension();
+    //n->SetNode(fNSize, ...);
   }
-  fTNodes = new TClonesArray("TKDNodeInfo", fNTNodes);
-  for(int in=0; in<fNTNodes; in++) new ((*fTNodes)[in]) TKDNodeInfo(fNSize);
+  fLambda = n->GetNpar();
+  return kTRUE;
 }
 
 //_________________________________________________________________
@@ -74,16 +100,23 @@ TKDInterpolatorBase::~TKDInterpolatorBase()
     for(int idim=0; idim<fNSize; idim++) delete [] fRefPoints[idim] ;
     delete [] fRefPoints;
   }
-  if(fTNodes) delete fTNodes;
+  if(fNodes){ 
+    fNodes->Delete();
+    delete fNodes;
+  }
+  if(fNodesDraw) delete [] fNodesDraw;
+
+  TH2 *h2=NULL;
+  if((h2 = (TH2S*)gROOT->FindObject("hKDnodes"))) delete h2;
 }
 
 
 //__________________________________________________________________
 Bool_t TKDInterpolatorBase::GetCOGPoint(Int_t inode, Float_t *&coord, Float_t &val, Float_t &err) const
 {
-  if(inode < 0 || inode > fNTNodes) return kFALSE;
+  if(inode < 0 || inode > GetNTNodes()) return kFALSE;
 
-  TKDNodeInfo *node = (TKDNodeInfo*)(*fTNodes)[inode];
+  TKDNodeInfo *node = (TKDNodeInfo*)(*fNodes)[inode];
   coord = &(node->Data()[0]);
   val = node->Val()[0];
   err = node->Val()[1];
@@ -93,25 +126,52 @@ Bool_t     TKDInterpolatorBase::GetCOGPoint(Int_t inode, Float_t *&coord, Float_t &v
 //_________________________________________________________________
 TKDNodeInfo* TKDInterpolatorBase::GetNodeInfo(Int_t inode) const
 {
-  if(!fTNodes || inode >= fNTNodes) return 0x0;
-  return (TKDNodeInfo*)(*fTNodes)[inode];
+  if(!fNodes || inode >= GetNTNodes()) return NULL;
+  return (TKDNodeInfo*)(*fNodes)[inode];
+}
+
+//_________________________________________________________________
+Int_t TKDInterpolatorBase::GetNTNodes() const 
+{
+  return fNodes?fNodes->GetEntriesFast():0;
 }
 
+//_________________________________________________________________
+Bool_t TKDInterpolatorBase::GetRange(Int_t ax, Float_t &min, Float_t &max) const
+{
+  if(!fNodes) return kFALSE;
+  Int_t ndim = ((TKDNodeInfo*)(*fNodes)[0])->GetDimension();
+  if(ax<0 || ax>=ndim){
+    min=0.; max=0.;
+    return kFALSE;
+  }
+  min=1.e10; max=-1.e10;
+  Float_t axmin, axmax;
+  for(Int_t in=GetNTNodes(); in--; ){ 
+    TKDNodeInfo *node = (TKDNodeInfo*)((*fNodes)[in]);
+    node->GetBoundary(ax, axmin, axmax);
+    if(axmin<min) min = axmin;
+    if(axmax>max) max = axmax;
+  }
+  
+  return kTRUE;
+}
 
 //__________________________________________________________________
-void TKDInterpolatorBase::GetStatus()
+void TKDInterpolatorBase::GetStatus(Option_t *opt)
 {
 // Prints the status of the interpolator
 
-  printf("Interpolator Status :\n");
+  printf("Interpolator Status[%d] :\n", fStatus);
   printf("  Dim    : %d [%d]\n", fNSize, fLambda);
-  printf("  Method : %s\n", fStatus&1 ? "INT" : "COG");
-  printf("  Store  : %s\n", fStatus&2 ? "YES" : "NO");
-  printf("  Weights: %s\n", fStatus&4 ? "YES" : "NO");
+  printf("  Method : %s\n", UseCOG() ? "COG" : "INT");
+  printf("  Store  : %s\n", HasStore() ? "YES" : "NO");
+  printf("  Weights: %s\n", UseWeights() ? "YES" : "NO");
   
-  printf("fNTNodes %d\n", fNTNodes);        //Number of evaluation data points
-  for(int i=0; i<fNTNodes; i++){
-    TKDNodeInfo *node = (TKDNodeInfo*)(*fTNodes)[i]; 
+  if(strcmp(opt, "all") != 0 ) return;
+  printf("GetNTNodes() %d\n", GetNTNodes());        //Number of evaluation data points
+  for(int i=0; i<GetNTNodes(); i++){
+    TKDNodeInfo *node = (TKDNodeInfo*)(*fNodes)[i]; 
     printf("%d ", i); node->Print();
   }
 }
@@ -125,36 +185,40 @@ Double_t TKDInterpolatorBase::Eval(const Double_t *point, Double_t &result, Doub
 //
 // 1. The default method used for interpolation is kCOG.
 // 2. The initial number of neighbors used for the estimation is set to Int(alpha*fLambda) (alpha = 1.5)
-      
+                   
   Float_t pointF[50]; // local Float_t conversion for "point"
   for(int idim=0; idim<fNSize; idim++) pointF[idim] = (Float_t)point[idim];
   Int_t nodeIndex = GetNodeIndex(pointF);
-  if(nodeIndex<0){
-    Error("TKDInterpolatorBase::Eval()", "Can not retrive node for data point.");
-    result = 0.;
+  if(nodeIndex<0){ 
+    Error("TKDInterpolatorBase::Eval()", "Can not retrive node for data point.");      
+    result = 0.;   
     error = 1.E10;
     return 0.;
   }
-  TKDNodeInfo *node = (TKDNodeInfo*)(*fTNodes)[nodeIndex];
-  if((fStatus&1) && node->Cov() && !force) return node->CookPDF(point, result, error);
+  TKDNodeInfo *node = (TKDNodeInfo*)(*fNodes)[nodeIndex];
+  if(node->Par() && !force){ 
+    //printf("Node @ %d\n", nodeIndex); node->Print("a");
+    return node->CookPDF(point, result, error);
+  }
 
   // Allocate memory
   if(!fBuffer) fBuffer = new Double_t[2*fLambda];
   if(!fKDhelper){ 
     fRefPoints = new Float_t*[fNSize];
     for(int id=0; id<fNSize; id++){
-      fRefPoints[id] = new Float_t[fNTNodes];
-      for(int in=0; in<fNTNodes; in++) fRefPoints[id][in] = ((TKDNodeInfo*)(*fTNodes)[in])->Data()[id];
+      fRefPoints[id] = new Float_t[GetNTNodes()];
+      for(int in=0; in<GetNTNodes(); in++) fRefPoints[id][in] = ((TKDNodeInfo*)(*fNodes)[in])->Data()[id];
     }
-    fKDhelper = new TKDTreeIF(fNTNodes, fNSize, kNhelper, fRefPoints);
+    Info("TKDInterpolatorBase::Eval()", Form("Build TKDTree(%d, %d, %d)", GetNTNodes(), fNSize, kNhelper));
+    fKDhelper = new TKDTreeIF(GetNTNodes(), fNSize, kNhelper, fRefPoints);
     fKDhelper->Build();
     fKDhelper->MakeBoundariesExact();
   }
   if(!fFitter) fFitter = new TLinearFitter(fLambda, Form("hyp%d", fLambda-1));
   
   // generate parabolic for nD
-  //Float_t alpha = Float_t(2*lambda + 1) / fNTNodes; // the bandwidth or smoothing parameter
-  //Int_t npoints = Int_t(alpha * fNTNodes);
+  //Float_t alpha = Float_t(2*lambda + 1) / GetNTNodes(); // the bandwidth or smoothing parameter
+  //Int_t npoints = Int_t(alpha * GetNTNodes());
   //printf("Params : %d NPoints %d\n", lambda, npoints);
   // prepare workers
 
@@ -169,15 +233,18 @@ Double_t TKDInterpolatorBase::Eval(const Double_t *point, Double_t &result, Doub
 
   Bool_t kDOWN = kFALSE;
   do{
+    if(npoints){
+      Info("TKDInterpolatorBase::Eval()", Form("Interpolation failed. Trying to increase the number of interpolation points from %d to %d.", npoints, npoints_new));
+    }
     if(npoints == npoints_new){
       Error("TKDInterpolatorBase::Eval()", Form("Interpolation failed and number of interpolation points (%d) Can not be increased further.", npoints));
       result = 0.;
       error = 1.E10;
       return 0.;
     } else npoints = npoints_new;
-    if(npoints > fNTNodes){
-      Warning("TKDInterpolatorBase::Eval()", Form("The number of interpolation points requested (%d) exceeds number of PDF values (%d). Downscale.", npoints, fNTNodes));
-      npoints = fNTNodes;
+    if(npoints > GetNTNodes()){
+      Warning("TKDInterpolatorBase::Eval()", Form("The number of interpolation points requested (%d) exceeds number of PDF values (%d). Downscale.", npoints, GetNTNodes()));
+      npoints = GetNTNodes();
       kDOWN = kTRUE;
     }
 
@@ -187,11 +254,18 @@ Double_t TKDInterpolatorBase::Eval(const Double_t *point, Double_t &result, Doub
 
     // add points to fitter
     fFitter->ClearPoints();
-    TKDNodeInfo *tnode = 0x0;
+    TKDNodeInfo *tnode = NULL;
     for(int in=0; in<npoints; in++){
-      tnode = (TKDNodeInfo*)(*fTNodes)[index[in]];
+      tnode = (TKDNodeInfo*)(*fNodes)[index[in]];
       //tnode->Print();
-      if(fStatus&1){ // INT
+      if(UseCOG()){ // COG
+        Float_t *p = &(tnode->Data()[0]);
+        ipar = 0;
+        for(int idim=0; idim<fNSize; idim++){
+          fBuffer[ipar++] = p[idim];
+          for(int jdim=idim; jdim<fNSize; jdim++) fBuffer[ipar++] = p[idim]*p[jdim];
+        }
+      } else { // INT
         Float_t *bounds = &(tnode->Data()[fNSize]);
         ipar = 0;
         for(int idim=0; idim<fNSize; idim++){
@@ -199,24 +273,18 @@ Double_t TKDInterpolatorBase::Eval(const Double_t *point, Double_t &result, Doub
           fBuffer[ipar++] = (bounds[2*idim]*bounds[2*idim] + bounds[2*idim] * bounds[2*idim+1] + bounds[2*idim+1] * bounds[2*idim+1])/3.;
           for(int jdim=idim+1; jdim<fNSize; jdim++) fBuffer[ipar++] = (bounds[2*idim] + bounds[2*idim+1]) * (bounds[2*jdim] + bounds[2*jdim+1]) * .25;
         }
-      } else { // COG
-        Float_t *p = &(tnode->Data()[0]);
-        ipar = 0;
-        for(int idim=0; idim<fNSize; idim++){
-          fBuffer[ipar++] = p[idim];
-          for(int jdim=idim; jdim<fNSize; jdim++) fBuffer[ipar++] = p[idim]*p[jdim];
-        }
       }
 
       // calculate tri-cubic weighting function
-      if(fStatus&4){
-        d = dist[in]/ dist[npoints];
+      if(UseWeights()){
+        d = dist[in]/dist[npoints];
         w0 = (1. - d*d*d); w = w0*w0*w0;
+        if(w<1.e-30) continue;
       } else w = 1.;
       
-//       printf("%2d x[", index[in]);
+//       printf("%2d d[%f] w[%f] x[", index[in], d, w);
 //       for(int idim=0; idim<fLambda-1; idim++) printf("%f ", fBuffer[idim]);
-//       printf("]  v[%f +- %f] (%f, %f)\n", tnode->Val()[0], tnode->Val()[1]/w, tnode->Val()[1], w);
+//       printf("]\n");  printf("v[%f +- %f] (%f, %f)\n", tnode->Val()[0], tnode->Val()[1]/w, tnode->Val()[1], w);
       fFitter->AddPoint(fBuffer, tnode->Val()[0], tnode->Val()[1]/w);
     }
     npoints_new = npoints+ (kDOWN ? 0 : kdN);
@@ -232,7 +300,7 @@ Double_t TKDInterpolatorBase::Eval(const Double_t *point, Double_t &result, Doub
   Double_t chi2 = fFitter->GetChisquare()/(npoints - 4 - fLambda);
 
   // store results
-  if(fStatus&2 && fStatus&1) node->Store(par, cov);
+  node->Store(&par, HasStore()?&cov:NULL);
     
   // Build df/dpi|x values
   Double_t *fdfdp = &fBuffer[fLambda];
@@ -250,50 +318,39 @@ Double_t TKDInterpolatorBase::Eval(const Double_t *point, Double_t &result, Doub
     for(int j=0; j<fLambda; j++) error += fdfdp[i]*fdfdp[j]*cov(i,j);
   }    
   error = TMath::Sqrt(error);
-
   return chi2;
 }
 
 //_________________________________________________________________
-void TKDInterpolatorBase::DrawBins(UInt_t ax1, UInt_t ax2, Float_t ax1min, Float_t ax1max, Float_t ax2min, Float_t ax2max)
+void TKDInterpolatorBase::DrawProjection(UInt_t ax1, UInt_t ax2)
 {
 // Draw nodes structure projected on plane "ax1:ax2". The parameter
 // "depth" specifies the bucket size per node. If depth == -1 draw only
 // terminal nodes and evaluation points (default -1 i.e. bucket size per node equal bucket size specified by the user)
 //
-// Observation:
-// This function creates the nodes (TBox) array for the specified depth
-// but don't delete it. Abusing this function may cause memory leaks !
-
-
   
-  TH2 *h2 = new TH2S("hNodes", "", 100, ax1min, ax1max, 100, ax2min, ax2max);
+  Float_t ax1min, ax1max, ax2min, ax2max;
+  GetRange(ax1, ax1min, ax1max);
+  GetRange(ax2, ax2min, ax2max);
+  TH2 *h2 = NULL;
+  if(!(h2 = (TH2S*)gROOT->FindObject("hKDnodes"))){
+    h2 = new TH2S("hKDnodes", "", 100, ax1min, ax1max, 100, ax2min, ax2max);
+  }
+  h2->GetXaxis()->SetRangeUser(ax1min, ax1max);
   h2->GetXaxis()->SetTitle(Form("x_{%d}", ax1));
+  h2->GetYaxis()->SetRangeUser(ax2min, ax2max);
   h2->GetYaxis()->SetTitle(Form("x_{%d}", ax2));
   h2->Draw();
-  
-  const Float_t kBorder = 0.;//1.E-4;
-  TBox *boxArray = new TBox[fNTNodes], *box;
-  Float_t *bounds = 0x0;
-  for(int inode = 0; inode < fNTNodes; inode++){
-    box = &boxArray[inode];
-    box->SetFillStyle(3002);
-    box->SetFillColor(50+Int_t(gRandom->Uniform()*50.));
-    
-    bounds = &(((TKDNodeInfo*)(*fTNodes)[inode])->Data()[fNSize]);
-    box->DrawBox(bounds[2*ax1]+kBorder, bounds[2*ax2]+kBorder, bounds[2*ax1+1]-kBorder, bounds[2*ax2+1]-kBorder);
-  }
 
-  // Draw reference points
-  TGraph *ref = new TGraph(fNTNodes);
-  ref->SetMarkerStyle(3);
-  ref->SetMarkerSize(.7);
-  ref->SetMarkerColor(2);
-  for(int inode = 0; inode < fNTNodes; inode++){
-    TKDNodeInfo *node = (TKDNodeInfo*)(*fTNodes)[inode];
-    ref->SetPoint(inode, node->Data()[ax1], node->Data()[ax2]);
+
+  if(!fNodesDraw) fNodesDraw = new TKDNodeInfo::TKDNodeDraw[GetNTNodes()]; 
+  TKDNodeInfo::TKDNodeDraw *box = NULL;
+  for(Int_t in=GetNTNodes(); in--; ){ 
+    box = &(fNodesDraw[in]);
+    box->SetNode((TKDNodeInfo*)((*fNodes)[in]), fNSize, ax1, ax2);
+    box->Draw();
   }
-  ref->Draw("p");
+
   return;
 }
 
@@ -306,40 +363,13 @@ void TKDInterpolatorBase::SetAlpha(Float_t a)
     return;
   }
   // check value
-  if(Int_t((a+1.)*fLambda) > fNTNodes){
-    fAlpha = TMath::Max(0.5, Float_t(fNTNodes)/fLambda-1.);
+  if(Int_t((a+1.)*fLambda) > GetNTNodes()){
+    fAlpha = TMath::Max(0.5, Float_t(GetNTNodes())/fLambda-1.);
     Warning("TKDInterpolatorBase::SetAlpha()", Form("Interpolation neighborhood  exceeds number of evaluation points. Downscale alpha to %f", fAlpha));
-    printf("n[%d] nodes[%d]\n", Int_t((fAlpha+1.)*fLambda), fNTNodes);
+    printf("n[%d] nodes[%d]\n", Int_t((fAlpha+1.)*fLambda), GetNTNodes());
     return;
   }
   fAlpha = a;
   return;
 }
 
-//__________________________________________________________________
-void TKDInterpolatorBase::SetInterpolationMethod(Bool_t on)
-{
-// Set interpolation bit to "on".
-  
-  if(on) fStatus += fStatus&1 ? 0 : 1;
-  else fStatus += fStatus&1 ? -1 : 0;
-}
-
-
-//_________________________________________________________________
-void TKDInterpolatorBase::SetStore(Bool_t on)
-{
-// Set store bit to "on"
-  
-  if(on) fStatus += fStatus&2 ? 0 : 2;
-  else fStatus += fStatus&2 ? -2 : 0;
-}
-
-//_________________________________________________________________
-void TKDInterpolatorBase::SetWeights(Bool_t on)
-{
-// Set weights bit to "on"
-  
-  if(on) fStatus += fStatus&4 ? 0 : 4;
-  else fStatus += fStatus&4 ? -4 : 0;
-}