ROOT logo

/**********************************************************************************
 * Project: TMVA - a Root-integrated toolkit for multivariate data analysis       *
 * Package: TMVA                                                                  *
 * Classes: PDEFoam                                                               *
 * Web    : http://tmva.sourceforge.net                                           *
 *                                                                                *
 * Description:                                                                   *
 *      Implementations                                                           *
 *                                                                                *
 * Authors (alphabetical):                                                        *
 *      Tancredi Carli   - CERN, Switzerland                                      *
 *      Dominik Dannheim - CERN, Switzerland                                      *
 *      S. Jadach        - Institute of Nuclear Physics, Cracow, Poland           *
 *      Alexander Voigt  - CERN, Switzerland                                      *
 *      Peter Speckmayer - CERN, Switzerland                                      *
 *                                                                                *
 * Copyright (c) 2008:                                                            *
 *      CERN, Switzerland                                                         *
 *      MPI-K Heidelberg, Germany                                                 *
 *                                                                                *
 * Redistribution and use in source and binary forms, with or without             *
 * modification, are permitted according to the terms listed in LICENSE           *
 * (http://tmva.sourceforge.net/LICENSE)                                          *
 **********************************************************************************/

//_____________________________________________________________________
//
// Implementation of PDEFoam
//
// The PDEFoam method is an
// extension of the PDERS method, which uses self-adapting binning to
// divide the multi-dimensional phase space in a finite number of
// hyper-rectangles (boxes).
//
// For a given number of boxes, the binning algorithm adjusts the size
// and position of the boxes inside the multidimensional phase space,
// minimizing the variance of the signal and background densities inside
// the boxes. The binned density information is stored in binary trees,
// allowing for a very fast and memory-efficient classification of
// events.
//
// The implementation of the PDEFoam is based on the monte-carlo
// integration package PDEFoam included in the analysis package ROOT.
//_____________________________________________________________________


#include <iostream>
#include <iomanip>
#include <fstream>
#include <sstream>
#include <cassert>

#include "TMVA/Event.h"
#include "TMVA/Tools.h"
#include "TMVA/PDEFoam.h"
#include "TMVA/MsgLogger.h"
#include "TMVA/Types.h"

#ifndef ROOT_TStyle
#include "TStyle.h"
#endif
#ifndef ROOT_TObject
#include "TObject.h"
#endif
#ifndef ROOT_TH1D
#include "TH1D.h"
#endif
#ifndef ROOT_TMath
#include "TMath.h"
#endif
#ifndef ROOT_TVectorT
#include "TVectorT.h"
#endif
#ifndef ROOT_TRandom3
#include "TRandom3.h"
#endif
#ifndef ROOT_TColor
#include "TColor.h"
#endif

ClassImp(TMVA::PDEFoam)

static const Float_t gHigh= FLT_MAX;
static const Float_t gVlow=-FLT_MAX;

using namespace std;

//_____________________________________________________________________
TMVA::PDEFoam::PDEFoam() :
   fLogger(new MsgLogger("PDEFoam"))
{
   // Default constructor for streamer, user should not use it.
   fDim      = 0;
   fNoAct    = 1;
   fNCells   = 0;
   fMaskDiv  = 0;
   fInhiDiv  = 0;
   fCells    = 0;
   fAlpha    = 0;
   fHistEdg  = 0;
   fRvec     = 0;
   fPseRan   = new TRandom3(4356);  // generator of pseudorandom numbers

   fFoamType  = kSeparate;
   fXmin      = 0;
   fXmax      = 0;
   fNElements = 0;
   fCutNmin   = kTRUE;
   fNmin      = 100;  // only used, when fCutMin == kTRUE
   fCutRMSmin = kFALSE;
   fRMSmin    = 1.0;

   SetPDEFoamVolumeFraction(-1.);

   fSignalClass     = -1;
   fBackgroundClass = -1;

   fDistr = new PDEFoamDistr();
   fDistr->SetSignalClass( fSignalClass );
   fDistr->SetBackgroundClass( fBackgroundClass );

   fTimer = new Timer(fNCells, "PDEFoam", kTRUE);
   fVariableNames = new TObjArray();
}

//_____________________________________________________________________
TMVA::PDEFoam::PDEFoam(const TString& Name) :
   fLogger(new MsgLogger("PDEFoam"))
{
   // User constructor, to be employed by the user

   if(strlen(Name)  >129) {
      Log() << kFATAL << "Name too long " << Name.Data() << Endl;
   }
   fName     = Name;          // Class name
   fMaskDiv  = 0;             // Dynamic Mask for  cell division, h-cubic
   fInhiDiv  = 0;             // Flag allowing to inhibit cell division in certain projection/edge
   fCells    = 0;
   fAlpha    = 0;
   fHistEdg  = 0;
   fDim      = 0;                // dimension of hyp-cubical space
   fNCells   = 1000;             // Maximum number of Cells,    is usually re-set
   fNSampl   = 200;              // No of sampling when dividing cell
   //------------------------------------------------------
   fNBin     = 8;                // binning of edge-histogram in cell exploration
   fEvPerBin =25;                // maximum no. of EFFECTIVE event per bin, =0 option is inactive
   //------------------------------------------------------
   fLastCe   =-1;                // Index of the last cell
   fNoAct    = 1;                // No of active cells (used in MC generation)
   fPseRan   = new TRandom3(4356);   // Initialize private copy of random number generator

   fFoamType  = kSeparate;
   fXmin      = 0;
   fXmax      = 0;
   fCutNmin   = kFALSE;
   fCutRMSmin = kFALSE;
   SetPDEFoamVolumeFraction(-1.);

   fSignalClass     = -1;
   fBackgroundClass = -1;

   fDistr = new PDEFoamDistr();
   fDistr->SetSignalClass( fSignalClass );
   fDistr->SetBackgroundClass( fBackgroundClass );

   fTimer = new Timer(fNCells, "PDEFoam", kTRUE);
   fVariableNames = new TObjArray();

   Log().SetSource( "PDEFoam" );
}

//_____________________________________________________________________
TMVA::PDEFoam::~PDEFoam()
{
   // Default destructor

   delete fVariableNames;
   delete fTimer;
   delete fDistr;
   delete fPseRan;
   if (fXmin) delete [] fXmin;  fXmin=0;
   if (fXmax) delete [] fXmax;  fXmax=0;

   if(fCells!= 0) {
      for(Int_t i=0; i<fNCells; i++) delete fCells[i]; // PDEFoamCell*[]
      delete [] fCells;
   }
   delete [] fRvec;    //double[]
   delete [] fAlpha;   //double[]
   delete [] fMaskDiv; //int[]
   delete [] fInhiDiv; //int[]

   delete fLogger;
}

//_____________________________________________________________________
TMVA::PDEFoam::PDEFoam(const PDEFoam &From):
   TObject(From),
   fLogger( new MsgLogger("PDEFoam"))
{
   // Copy Constructor  NOT IMPLEMENTED (NEVER USED)
   Log() << kFATAL << "COPY CONSTRUCTOR NOT IMPLEMENTED" << Endl;
}

//_____________________________________________________________________
void TMVA::PDEFoam::SetkDim(Int_t kDim) 
{ 
   // Sets dimension of cubical space
   if (kDim < 1)
      Log() << kFATAL << "<SetkDim>: Dimension is zero or negative!" << Endl;

   fDim = kDim;
   if (fXmin) delete [] fXmin;
   if (fXmax) delete [] fXmax;
   fXmin = new Double_t[GetTotDim()];
   fXmax = new Double_t[GetTotDim()];
}

//_____________________________________________________________________
void TMVA::PDEFoam::SetXmin(Int_t idim, Double_t wmin)
{
   // set lower foam bound in dimension idim
   if (idim<0 || idim>=GetTotDim())
      Log() << kFATAL << "<SetXmin>: Dimension out of bounds!" << Endl;

   fXmin[idim]=wmin;
   fDistr->SetXmin(idim, wmin);
}

//_____________________________________________________________________
void TMVA::PDEFoam::SetXmax(Int_t idim, Double_t wmax)
{
   // set upper foam bound in dimension idim
   if (idim<0 || idim>=GetTotDim())
      Log() << kFATAL << "<SetXmax>: Dimension out of bounds!" << Endl;

   fXmax[idim]=wmax;
   fDistr->SetXmax(idim, wmax);
}

//_____________________________________________________________________
void TMVA::PDEFoam::Create(Bool_t CreateCellElements)
{
   // Basic initialization of FOAM invoked by the user.
   // IMPORTANT: Random number generator and the distribution object has to be
   // provided using SetPseRan and SetRho prior to invoking this initializator!

   Bool_t addStatus = TH1::AddDirectoryStatus();
   TH1::AddDirectory(kFALSE);

   if(fPseRan==0) Log() << kFATAL << "Random number generator not set" << Endl;
   if(fDistr==0)  Log() << kFATAL << "Distribution function not set" << Endl;
   if(fDim==0)    Log() << kFATAL << "Zero dimension not allowed" << Endl;

   /////////////////////////////////////////////////////////////////////////
   //                   ALLOCATE SMALL LISTS                              //
   //  it is done globally, not for each cell, to save on allocation time //
   /////////////////////////////////////////////////////////////////////////
   fRvec = new Double_t[fDim];   // Vector of random numbers
   if(fRvec==0)  Log() << kFATAL << "Cannot initialize buffer fRvec" << Endl;

   if(fDim>0){
      fAlpha = new Double_t[fDim];    // sum<1 for internal parametrization of the simplex
      if(fAlpha==0)  Log() << kFATAL << "Cannot initialize buffer fAlpha" << Endl;
   }

   //====== List of directions inhibited for division
   if(fInhiDiv == 0){
      fInhiDiv = new Int_t[fDim];
      for(Int_t i=0; i<fDim; i++) fInhiDiv[i]=0;
   }
   //====== Dynamic mask used in Explore for edge determination
   if(fMaskDiv == 0){
      fMaskDiv = new Int_t[fDim];
      for(Int_t i=0; i<fDim; i++) fMaskDiv[i]=1;
   }
   //====== Initialize list of histograms
   fHistEdg = new TObjArray(fDim);           // Initialize list of histograms
   for(Int_t i=0; i<fDim; i++){
      TString hname, htitle;
      hname   = fName+TString("_HistEdge_");
      hname  += i;
      htitle  = TString("Edge Histogram No. ");
      htitle += i;
      (*fHistEdg)[i] = new TH1D(hname.Data(),htitle.Data(),fNBin,0.0, 1.0); // Initialize histogram for each edge
      ((TH1D*)(*fHistEdg)[i])->Sumw2();
   }

   // ||||||||||||||||||||||||||||||||||||||||||||||||||||||||||||||||||| //
   //                     BUILD-UP of the FOAM                            //
   // ||||||||||||||||||||||||||||||||||||||||||||||||||||||||||||||||||| //

   // Define and explore root cell(s)
   InitCells(CreateCellElements);
   Grow();

   TH1::AddDirectory(addStatus);
} // Create

//_____________________________________________________________________
void TMVA::PDEFoam::InitCells(Bool_t CreateCellElements)
{
   // Internal subprogram used by Create.
   // It initializes "root part" of the FOAM of the tree of cells.

   fLastCe =-1;                             // Index of the last cell
   if(fCells!= 0) {
      for(Int_t i=0; i<fNCells; i++) delete fCells[i];
      delete [] fCells;
   }
   //
   fCells = new PDEFoamCell*[fNCells];
   for(Int_t i=0; i<fNCells; i++){
      fCells[i]= new PDEFoamCell(fDim); // Allocate BIG list of cells
      fCells[i]->SetSerial(i);
   }
   if(fCells==0) Log() << kFATAL << "Cannot initialize CELLS" << Endl;

   // create cell elemets
   if (CreateCellElements)
      ResetCellElements(true);

   /////////////////////////////////////////////////////////////////////////////
   //              Single Root Hypercube                                      //
   /////////////////////////////////////////////////////////////////////////////
   CellFill(1,   0);  //  0-th cell ACTIVE

   // Exploration of the root cell(s)
   for(Long_t iCell=0; iCell<=fLastCe; iCell++){
      Explore( fCells[iCell] );               // Exploration of root cell(s)
   }
}//InitCells

//_____________________________________________________________________
Int_t TMVA::PDEFoam::CellFill(Int_t Status, PDEFoamCell *parent)
{
   // Internal subprogram used by Create.
   // It initializes content of the newly allocated active cell.

   PDEFoamCell *cell;
   if (fLastCe==fNCells){
      Log() << kFATAL << "Too many cells" << Endl;
   }
   fLastCe++;   // 0-th cell is the first

   cell = fCells[fLastCe];

   cell->Fill(Status, parent, 0, 0);

   cell->SetBest( -1);         // pointer for planning division of the cell
   cell->SetXdiv(0.5);         // factor for division
   Double_t xInt2,xDri2;
   if(parent!=0){
      xInt2  = 0.5*parent->GetIntg();
      xDri2  = 0.5*parent->GetDriv();
      cell->SetIntg(xInt2);
      cell->SetDriv(xDri2);
   }else{
      cell->SetIntg(0.0);
      cell->SetDriv(0.0);
   }
   return fLastCe;
}

//_____________________________________________________________________
void TMVA::PDEFoam::Explore(PDEFoamCell *cell)
{
   // Internal subprogram used by Create.
   // It explores newly defined cell with help of special short MC sampling.
   // As a result, estimates of kTRUE and drive volume is defined/determined
   // Average and dispersion of the weight distribution will is found along
   // each edge and the best edge (minimum dispersion, best maximum weight)
   // is memorized for future use.
   // The optimal division point for eventual future cell division is
   // determined/recorded. Recorded are also minimum and maximum weight etc.
   // The volume estimate in all (inactive) parent cells is updated.
   // Note that links to parents and initial volume = 1/2 parent has to be
   // already defined prior to calling this routine.
   //
   // This function is overridden from the original PDEFoam::Explore()
   // to provide an extra option:   Filling edge histograms directly from the
   // input distributions, w/o MC sampling if fNSampl == 0
   // Warning:  This option is not tested jet!

   Double_t wt, dx, xBest, yBest;
   Double_t intOld, driOld;

   Long_t iev;
   Double_t nevMC;
   Int_t i, j, k;
   Int_t nProj, kBest;
   Double_t ceSum[5], xproj;

   Double_t event_density = 0;
   Double_t totevents     = 0;
   Double_t toteventsOld  = 0;

   PDEFoamVect  cellSize(fDim);
   PDEFoamVect  cellPosi(fDim);

   cell->GetHcub(cellPosi,cellSize);

   PDEFoamCell  *parent;

   Double_t *xRand = new Double_t[fDim];

   Double_t *volPart=0;

   cell->CalcVolume();
   dx = cell->GetVolume();
   intOld = cell->GetIntg(); //memorize old values,
   driOld = cell->GetDriv(); //will be needed for correcting parent cells
   if (CutNmin())
      toteventsOld = GetBuildUpCellEvents(cell);

   /////////////////////////////////////////////////////
      //    Special Short MC sampling to probe cell      //
      /////////////////////////////////////////////////////
      ceSum[0]=0;
      ceSum[1]=0;
      ceSum[2]=0;
      ceSum[3]=gHigh;  //wtmin
      ceSum[4]=gVlow;  //wtmax

      for (i=0;i<fDim;i++) ((TH1D *)(*fHistEdg)[i])->Reset(); // Reset histograms

      Double_t nevEff=0.;
      // ||||||||||||||||||||||||||BEGIN MC LOOP|||||||||||||||||||||||||||||
      for (iev=0;iev<fNSampl;iev++){
         MakeAlpha();               // generate uniformly vector inside hypercube

         if (fDim>0){
            for (j=0; j<fDim; j++)
               xRand[j]= cellPosi[j] +fAlpha[j]*(cellSize[j]);
         }

         wt         = dx*Eval(xRand, event_density);
         totevents += dx*event_density;

         nProj = 0;
         if (fDim>0) {
            for (k=0; k<fDim; k++) {
               xproj =fAlpha[k];
               ((TH1D *)(*fHistEdg)[nProj])->Fill(xproj,wt);
               nProj++;
            }
         }

         ceSum[0] += wt;    // sum of weights
         ceSum[1] += wt*wt; // sum of weights squared
         ceSum[2]++;        // sum of 1
         if (ceSum[3]>wt) ceSum[3]=wt;  // minimum weight;
         if (ceSum[4]<wt) ceSum[4]=wt;  // maximum weight
         // test MC loop exit condition
         nevEff = ceSum[0]*ceSum[0]/ceSum[1];
         if ( nevEff >= fNBin*fEvPerBin) break;
      }   // ||||||||||||||||||||||||||END MC LOOP|||||||||||||||||||||||||||||
      totevents /= fNSampl;

      // make shure that, if root cell is explored, more than zero
      // events were found.
      if (cell==fCells[0] && ceSum[0]<=0.0){
         if (ceSum[0]==0.0)
            Log() << kFATAL << "No events were found during exploration of "
                  << "root cell.  Please check PDEFoam parameters nSampl "
                  << "and VolFrac." << Endl;
         else
            Log() << kWARNING << "Negative number of events found during "
                  << "exploration of root cell" << Endl;
      }

      //------------------------------------------------------------------
      //---  predefine logics of searching for the best division edge ---
      for (k=0; k<fDim;k++){
         fMaskDiv[k] =1;                       // default is all
         if ( fInhiDiv[k]==1) fMaskDiv[k] =0; // inhibit some...
      }
      kBest=-1;

      //------------------------------------------------------------------
      nevMC            = ceSum[2];
      Double_t intTrue = ceSum[0]/(nevMC+0.000001);
      Double_t intDriv=0.;

      if (kBest == -1) Varedu(ceSum,kBest,xBest,yBest); // determine the best edge,
      if (CutRMSmin())
         intDriv =sqrt( ceSum[1]/nevMC -intTrue*intTrue ); // Older ansatz, numerically not bad
      else
         intDriv =sqrt(ceSum[1]/nevMC) -intTrue; // Foam build-up, sqrt(<w**2>) -<w>

      //=================================================================================
      cell->SetBest(kBest);
      cell->SetXdiv(xBest);
      cell->SetIntg(intTrue);
      cell->SetDriv(intDriv);
      if (CutNmin())
         SetCellElement(cell, 0, totevents);

      // correct/update integrals in all parent cells to the top of the tree
      Double_t  parIntg, parDriv;
      for (parent = cell->GetPare(); parent!=0; parent = parent->GetPare()){
         parIntg = parent->GetIntg();
         parDriv = parent->GetDriv();
         parent->SetIntg( parIntg   +intTrue -intOld );
         parent->SetDriv( parDriv   +intDriv -driOld );
         if (CutNmin())
            SetCellElement( parent, 0, GetBuildUpCellEvents(parent) + totevents - toteventsOld);
      }
      delete [] volPart;
      delete [] xRand;
}

//_____________________________________________________________________
void TMVA::PDEFoam::Varedu(Double_t ceSum[5], Int_t &kBest, Double_t &xBest, Double_t &yBest)
{
   // Internal subrogram used by Create.
   // In determines the best edge candidate and the position of the cell division plane
   // in case of the variance reduction for future cell division,
   // using results of the MC exploration run stored in fHistEdg

   Double_t nent   = ceSum[2];
   Double_t swAll  = ceSum[0];
   Double_t sswAll = ceSum[1];
   Double_t ssw    = sqrt(sswAll)/sqrt(nent);
   //
   Double_t swIn,swOut,sswIn,sswOut,xLo,xUp;
   kBest =-1;
   xBest =0.5;
   yBest =1.0;
   Double_t maxGain=0.0;
   // Now go over all projections kProj
   for(Int_t kProj=0; kProj<fDim; kProj++) {
      if( fMaskDiv[kProj]) {
         // initialize search over bins
         Double_t sigmIn =0.0; Double_t sigmOut =0.0;
         Double_t sswtBest = gHigh;
         Double_t gain =0.0;
         Double_t xMin=0.0; Double_t xMax=0.0;
         // Double loop over all pairs jLo<jUp
         for(Int_t jLo=1; jLo<=fNBin; jLo++) {
            Double_t aswIn=0;  Double_t asswIn=0;
            for(Int_t jUp=jLo; jUp<=fNBin;jUp++) {
               aswIn  +=     ((TH1D *)(*fHistEdg)[kProj])->GetBinContent(jUp);
               asswIn += Sqr(((TH1D *)(*fHistEdg)[kProj])->GetBinError(  jUp));
               xLo=(jLo-1.0)/fNBin;
               xUp=(jUp*1.0)/fNBin;
               swIn  =        aswIn/nent;
               swOut = (swAll-aswIn)/nent;
               sswIn = sqrt(asswIn)       /sqrt(nent*(xUp-xLo))     *(xUp-xLo);
               sswOut= sqrt(sswAll-asswIn)/sqrt(nent*(1.0-xUp+xLo)) *(1.0-xUp+xLo);
               if( (sswIn+sswOut) < sswtBest) {
                  sswtBest = sswIn+sswOut;
                  gain     = ssw-sswtBest;
                  sigmIn   = sswIn -swIn;  // Debug
                  sigmOut  = sswOut-swOut; // Debug
                  xMin    = xLo;
                  xMax    = xUp;
               }
            }//jUp
         }//jLo
         Int_t iLo = (Int_t) (fNBin*xMin);
         Int_t iUp = (Int_t) (fNBin*xMax);

         if(gain>=maxGain) {
            maxGain=gain;
            kBest=kProj; // <--- !!!!! The best edge
            xBest=xMin;
            yBest=xMax;
            if(iLo == 0)     xBest=yBest; // The best division point
            if(iUp == fNBin) yBest=xBest; // this is not really used
         }
      }
   } //kProj

   if( (kBest >= fDim) || (kBest<0) )
      Log() << kFATAL << "Something wrong with kBest" << Endl;
}          //PDEFoam::Varedu

//_____________________________________________________________________
void TMVA::PDEFoam::MakeAlpha()
{
   // Internal subrogram used by Create.
   // Provides random vector Alpha  0< Alpha(i) < 1

   // simply generate and load kDim uniform random numbers
   fPseRan->RndmArray(fDim,fRvec);   // kDim random numbers needed
   for(Int_t k=0; k<fDim; k++) fAlpha[k] = fRvec[k];
} //MakeAlpha

//_____________________________________________________________________
Long_t TMVA::PDEFoam::PeekMax()
{
   // Internal subprogram used by Create.
   // It finds cell with maximal driver integral for the purpose of the division.
   // This function is overridden by the PDEFoam Class to apply cuts
   // on Nmin and RMSmin during cell buildup.

   Long_t iCell = -1;

   Long_t  i;
   Double_t  drivMax, driv;
   Bool_t bCutNmin = kTRUE;
   Bool_t bCutRMS  = kTRUE;
   //   drivMax = gVlow;
   drivMax = 0;  // only split cells if gain>0 (this also avoids splitting at cell boundary)
   for(i=0; i<=fLastCe; i++) {//without root
      if( fCells[i]->GetStat() == 1 ) {
         driv =  TMath::Abs( fCells[i]->GetDriv());
         // apply RMS-cut for all options
         if (CutRMSmin()){
            // calc error on rms, but how?
            bCutRMS = driv > GetRMSmin() /*&& driv > driv_err*/;
            Log() << kINFO << "rms[cell "<<i<<"]=" << driv << Endl;
         }

         // apply Nmin-cut
         if (CutNmin())
            bCutNmin = GetBuildUpCellEvents(fCells[i]) > GetNmin();

         // choose cell
         if(driv > drivMax && bCutNmin && bCutRMS) {
            drivMax = driv;
            iCell = i;
         }
      }
   }

   if (iCell == -1){
      if (!bCutNmin)
         Log() << kVERBOSE << "Warning: No cell with more than " << GetNmin() << " events found!" << Endl;
      else if (!bCutRMS)
         Log() << kVERBOSE << "Warning: No cell with RMS/mean > " << GetRMSmin() << " found!" << Endl;
      else
         Log() << kWARNING << "Warning: PDEFoam::PeekMax: no more candidate cells (drivMax>0) found for further splitting." << Endl;
   }

   return(iCell);
}

//_____________________________________________________________________
Int_t TMVA::PDEFoam::Divide(PDEFoamCell *cell)
{
   // Internal subrogram used by Create.
   // It divides cell iCell into two daughter cells.
   // The iCell is retained and tagged as inactive, daughter cells are appended
   // at the end of the buffer.
   // New vertex is added to list of vertices.
   // List of active cells is updated, iCell removed, two daughters added
   // and their properties set with help of MC sampling (PDEFoam_Explore)
   // Returns Code RC=-1 of buffer limit is reached,  fLastCe=fnBuf.

   Double_t xdiv;
   Int_t   kBest;

   if(fLastCe+1 >= fNCells) Log() << kFATAL << "Buffer limit is reached, fLastCe=fnBuf" << Endl;

   cell->SetStat(0); // reset cell as inactive
   fNoAct++;

   xdiv  = cell->GetXdiv();
   kBest = cell->GetBest();
   if( kBest<0 || kBest>=fDim ) Log() << kFATAL << "Wrong kBest" << Endl;

   //////////////////////////////////////////////////////////////////
   //           define two daughter cells (active)                 //
   //////////////////////////////////////////////////////////////////

   Int_t d1 = CellFill(1,   cell);
   Int_t d2 = CellFill(1,   cell);
   cell->SetDau0((fCells[d1]));
   cell->SetDau1((fCells[d2]));
   Explore( (fCells[d1]) );
   Explore( (fCells[d2]) );
   return 1;
} // PDEFoam_Divide

//_____________________________________________________________________
Double_t TMVA::PDEFoam::Eval(Double_t *xRand, Double_t &event_density)
{
   // Internal subprogram.
   // Evaluates distribution to be generated.
   return fDistr->Density(xRand, event_density);
}

//_____________________________________________________________________
void TMVA::PDEFoam::Grow()
{
   // Internal subrogram used by Create.
   // It grow new cells by the binary division process.
   // This function is overridden by the PDEFoam class to stop the foam buildup process
   // if one of the cut conditions stop the cell split.

   fTimer->Init(fNCells);

   Long_t iCell;
   PDEFoamCell* newCell;

   while ( (fLastCe+2) < fNCells ) {  // this condition also checked inside Divide
      iCell   = PeekMax();            // peek up cell with maximum driver integral
      if ( (iCell<0) || (iCell>fLastCe) ) {
         Log() << kVERBOSE << "Break: "<< fLastCe+1 << " cells created" << Endl;
         // remove remaining empty cells
         for (Long_t jCell=fLastCe+1; jCell<fNCells; jCell++)
            delete fCells[jCell];
         fNCells = fLastCe+1;
         break;
      }
      newCell = fCells[iCell];

      OutputGrow();

      if ( Divide( newCell )==0) break;  // and divide it into two
   }
   OutputGrow( kTRUE );
   CheckAll(1);   // set arg=1 for more info

   Log() << kINFO << GetNActiveCells() << " active cells created" << Endl;
}// Grow

//_____________________________________________________________________
void  TMVA::PDEFoam::SetInhiDiv(Int_t iDim, Int_t InhiDiv)
{
   // This can be called before Create, after setting kDim
   // It defines which variables are excluded in the process of the cell division.
   // For example 'FoamX->SetInhiDiv(1, 1);' inhibits division of y-variable.

   if(fDim==0) Log() << kFATAL << "SetInhiDiv: fDim=0" << Endl;
   if(fInhiDiv == 0) {
      fInhiDiv = new Int_t[ fDim ];
      for(Int_t i=0; i<fDim; i++) fInhiDiv[i]=0;
   }
   //
   if( ( 0<=iDim) && (iDim<fDim)) {
      fInhiDiv[iDim] = InhiDiv;
   } else
      Log() << kFATAL << "Wrong iDim" << Endl;
}//SetInhiDiv

//_____________________________________________________________________
void TMVA::PDEFoam::CheckAll(Int_t level)
{
   //  User utility, miscellaneous and debug.
   //  Checks all pointers in the tree of cells. This is useful autodiagnostic.
   //  level=0, no printout, failures causes STOP
   //  level=1, printout, failures lead to WARNINGS only

   Int_t errors, warnings;
   PDEFoamCell *cell;
   Long_t iCell;

   errors = 0; warnings = 0;
   if (level==1) Log() <<  "Performing consistency checks for created foam" << Endl;
   for(iCell=1; iCell<=fLastCe; iCell++) {
      cell = fCells[iCell];
      //  checking general rules
      if( ((cell->GetDau0()==0) && (cell->GetDau1()!=0) ) ||
          ((cell->GetDau1()==0) && (cell->GetDau0()!=0) ) ) {
         errors++;
         if (level==1) Log() << kFATAL << "ERROR: Cell's no %d has only one daughter " << iCell << Endl;
      }
      if( (cell->GetDau0()==0) && (cell->GetDau1()==0) && (cell->GetStat()==0) ) {
         errors++;
         if (level==1) Log() << kFATAL << "ERROR: Cell's no %d  has no daughter and is inactive " << iCell << Endl;
      }
      if( (cell->GetDau0()!=0) && (cell->GetDau1()!=0) && (cell->GetStat()==1) ) {
         errors++;
         if (level==1) Log() << kFATAL << "ERROR: Cell's no %d has two daughters and is active " << iCell << Endl;
      }

      // checking parents
      if( (cell->GetPare())!=fCells[0] ) { // not child of the root
         if ( (cell != cell->GetPare()->GetDau0()) && (cell != cell->GetPare()->GetDau1()) ) {
            errors++;
            if (level==1) Log() << kFATAL << "ERROR: Cell's no %d parent not pointing to this cell " << iCell << Endl;
         }
      }

      // checking daughters
      if(cell->GetDau0()!=0) {
         if(cell != (cell->GetDau0())->GetPare()) {
            errors++;
            if (level==1)  Log() << kFATAL << "ERROR: Cell's no %d daughter 0 not pointing to this cell " << iCell << Endl;
         }
      }
      if(cell->GetDau1()!=0) {
         if(cell != (cell->GetDau1())->GetPare()) {
            errors++;
            if (level==1) Log() << kFATAL << "ERROR: Cell's no %d daughter 1 not pointing to this cell " << iCell << Endl;
         }
      }
     if(cell->GetVolume()<1E-50) {
         errors++;
         if(level==1) Log() << kFATAL << "ERROR: Cell no. %d has Volume of <1E-50" << iCell << Endl;
     }
    }// loop after cells;

   // Check for cells with Volume=0
   for(iCell=0; iCell<=fLastCe; iCell++) {
      cell = fCells[iCell];
      if( (cell->GetStat()==1) && (cell->GetVolume()<1E-11) ) {
         errors++;
         if(level==1) Log() << kFATAL << "ERROR: Cell no. " << iCell << " is active but Volume is 0 " <<  Endl;
      }
   }
   // summary
   if(level==1){
     Log() << kINFO << "Check has found " << errors << " errors and " << warnings << " warnings." << Endl;
   }
   if(errors>0){
      Info("CheckAll","Check - found total %d  errors \n",errors);
   }
} // Check

//_____________________________________________________________________
void TMVA::PDEFoam::PrintCells(void)
{
   // Prints geometry of ALL cells of the FOAM

   Long_t iCell;

   for(iCell=0; iCell<=fLastCe; iCell++) {
      Log()<<"Cell["<<iCell<<"]={ ";
      Log()<<"  "<< fCells[iCell]<<"  ";  // extra DEBUG
      Log()<<Endl;
      fCells[iCell]->Print("1");
      Log()<<"}"<<Endl;
   }
}

//_____________________________________________________________________
void TMVA::PDEFoam::RemoveEmptyCell( Int_t iCell )
{
   // This function removes a cell iCell, which has a volume equal to zero.
   // It works the following way:
   // 1) find grandparent to iCell
   // 2) set daughter of the grandparent cell to the sister of iCell
   // Result:
   // iCell and its parent are alone standing ==> will be removed

   // get cell volume
   Double_t volume = fCells[iCell]->GetVolume();

   if (!fCells[iCell]->GetStat() || volume>0){
      Log() << "<RemoveEmptyCell>: cell " << iCell
              << "is not active or has volume>0 ==> doesn't need to be removed" << Endl;
      return;
   }

   // get parent and grandparent Cells
   PDEFoamCell *pCell  = fCells[iCell]->GetPare();
   PDEFoamCell *ppCell = fCells[iCell]->GetPare()->GetPare();

   // get neighbour (sister) to iCell
   PDEFoamCell *sCell;
   if (pCell->GetDau0() == fCells[iCell])
      sCell = pCell->GetDau1();
   else
      sCell = pCell->GetDau0();

   // cross check
   if (pCell->GetIntg() != sCell->GetIntg())
      Log() << kWARNING << "<RemoveEmptyCell> Error: cell integrals are not equal!"
              << " Intg(parent cell)=" << pCell->GetIntg()
              << " Intg(sister cell)=" << sCell->GetIntg()
              << Endl;

   // set daughter of grandparent to sister of iCell
   if (ppCell->GetDau0() == pCell)
      ppCell->SetDau0(sCell);
   else
      ppCell->SetDau1(sCell);

   // set parent of sister to grandparent of of iCell
   sCell->SetPare(ppCell);

   // now iCell and its parent are alone ==> set them inactive
   fCells[iCell]->SetStat(0);
   pCell->SetStat(0);
}

//_____________________________________________________________________
void TMVA::PDEFoam::CheckCells( Bool_t remove_empty_cells )
{
   // debug function: checks all cells with respect to critical
   // values, f.e. cell volume, ...

   for (Long_t iCell=0; iCell<=fLastCe; iCell++) {
      if (!fCells[iCell]->GetStat())
         continue;

      Double_t volume = fCells[iCell]->GetVolume();
      if (volume<1e-10){
         if (volume<=0){
            Log() << kWARNING << "Critical: cell volume negative or zero! volume="
                    << volume << " cell number: " << iCell << Endl;
            // fCells[iCell]->Print("1"); // debug output
            if (remove_empty_cells){
               Log() << kWARNING << "Remove cell " << iCell << Endl;
               RemoveEmptyCell(iCell);
            }
         }
         else {
            Log() << kWARNING << "Cell volume close to zero! volume="
                    << volume << " cell number: " << iCell << Endl;
         }
      }
   }
}

//_____________________________________________________________________
void TMVA::PDEFoam::PrintCellElements()
{
   // This debug function prints the cell elements of all active
   // cells.

   for (Long_t iCell=0; iCell<=fLastCe; iCell++) {
      if (!fCells[iCell]->GetStat()) continue;

      Log() << "cell[" << iCell << "] elements: [";
      for (UInt_t i=0; i<GetNElements(); i++){
         if (i>0) Log() << " ; ";
         Log() << GetCellElement(fCells[iCell], i);
      }
      Log() << "]" << Endl;
   }
}

//_____________________________________________________________________
void TMVA::PDEFoam::ResetCellElements(Bool_t allcells)
{
   // creates a TVectorD object with fNElements in every cell
   // and initializes them by zero.
   // The TVectorD object is used to store classification or
   // regression data in every foam cell.
   //
   // Parameter:
   //   allcells == true  : create TVectorD on every cell
   //   allcells == false : create TVectorD on active cells with
   //                       cell index <= fLastCe (default)

   if (!fCells || GetNElements()==0) return;

   // delete all old cell elements
   Log() << kVERBOSE << "Delete old cell elements" << Endl;
   for(Long_t iCell=0; iCell<fNCells; iCell++) {
      if (fCells[iCell]->GetElement() != 0){
         delete dynamic_cast<TVectorD*>(fCells[iCell]->GetElement());
         fCells[iCell]->SetElement(0);
      }
   }

   if (allcells){
      Log() << kVERBOSE << "Reset new cell elements to "
            << GetNElements() << " value(s) per cell" << Endl;
      // create new cell elements on every cell
      for(Long_t iCell=0; iCell<fNCells; iCell++) {
         TVectorD *elem = new TVectorD(GetNElements());

         for (UInt_t i=0; i<GetNElements(); i++)
            (*elem)(i) = 0.;

         fCells[iCell]->SetElement(elem);
      }
   } else {
      Log() << kVERBOSE << "Reset active cell elements to "
            << GetNElements() << " value(s) per cell" << Endl;
      // create new cell elements (only active cells with
      // cell index <= fLastCe)
      for(Long_t iCell=0; iCell<=fLastCe; iCell++) {
         // skip inactive cells
         if (!(fCells[iCell]->GetStat()))
            continue;

         TVectorD *elem = new TVectorD(GetNElements());

         for (UInt_t i=0; i<GetNElements(); i++)
            (*elem)(i) = 0.;

         fCells[iCell]->SetElement(elem);
      }
   }
}

//_____________________________________________________________________
void TMVA::PDEFoam::CalcCellTarget()
{
   // Calculate average cell target in every cell and save them to the cell.
   // This function is called when the Mono target regression option is set.

   // loop over cells
   for (Long_t iCell=0; iCell<=fLastCe; iCell++) {
      if (!(fCells[iCell]->GetStat()))
         continue;

      Double_t N_ev  = GetCellElement(fCells[iCell], 0); // get number of events
      Double_t tar   = GetCellElement(fCells[iCell], 1); // get sum of targets

      if (N_ev > 1e-20){
         SetCellElement(fCells[iCell], 0, tar/N_ev);  // set average target
         SetCellElement(fCells[iCell], 1, tar/TMath::Sqrt(N_ev)); // set error on average target
      }
      else {
         SetCellElement(fCells[iCell], 0, 0.0 ); // set mean target
         SetCellElement(fCells[iCell], 1, -1  ); // set mean target error
      }
   }
}

//_____________________________________________________________________
void TMVA::PDEFoam::CalcCellDiscr()
{
   // Calc discriminator and its error for every cell and save it to the cell.
   // This function is called when the fSigBgSeparated==False option is set.

   // loop over cells
   for (Long_t iCell=0; iCell<=fLastCe; iCell++) {
      if (!(fCells[iCell]->GetStat()))
         continue;

      Double_t N_sig = GetCellElement(fCells[iCell], 0); // get number of signal events
      Double_t N_bg  = GetCellElement(fCells[iCell], 1); // get number of bg events

      if (N_sig<0.) {
         Log() << kWARNING << "Negative number of signal events in cell " << iCell
               << ": " << N_sig << ". Set to 0." << Endl;
         N_sig=0.;
      }
      if (N_bg<0.) {
         Log() << kWARNING << "Negative number of background events in cell " << iCell
               << ": " << N_bg << ". Set to 0." << Endl;
         N_bg=0.;
      }


      if (N_sig+N_bg > 1e-10){
         SetCellElement(fCells[iCell], 0, N_sig/(N_sig+N_bg));  // set discriminator
         SetCellElement(fCells[iCell], 1, TMath::Sqrt( TMath::Power ( N_sig/TMath::Power(N_sig+N_bg,2),2)*N_sig +
                                                       TMath::Power ( N_bg /TMath::Power(N_sig+N_bg,2),2)*N_bg ) ); // set discriminator error

      }
      else {
         SetCellElement(fCells[iCell], 0, 0.5); // set discriminator
         SetCellElement(fCells[iCell], 1, 1. ); // set discriminator error
      }
   }
}

//_____________________________________________________________________
Double_t TMVA::PDEFoam::GetCellDiscr( std::vector<Float_t> xvec, EKernel kernel )
{
   // Get discriminator saved in cell (previously calculated in CalcCellDiscr())
   // which encloses the coordinates given in xvec.
   // This function is used, when the fSigBgSeparated==False option is set
   // (unified foams).

   Double_t result = 0.;

   // transform xvec
   std::vector<Float_t> txvec = VarTransform(xvec);

   // find cell
   PDEFoamCell *cell= FindCell(txvec);

   if (!cell) return -999.;

   if (kernel == kNone) result = GetCellValue(cell, kDiscriminator);
   else if (kernel == kGaus) {
      Double_t norm = 0.;

      for (Long_t iCell=0; iCell<=fLastCe; iCell++) {
         if (!(fCells[iCell]->GetStat())) continue;

         // calc cell density
         Double_t cell_discr = GetCellValue(fCells[iCell], kDiscriminator);
         Double_t gau        = WeightGaus(fCells[iCell], txvec);

         result += gau * cell_discr;
         norm   += gau;
      }

      result /= norm;
   }
   else if (kernel == kLinN) {
      result = WeightLinNeighbors(txvec, kDiscriminator);
   }
   else {
      Log() << kFATAL << "GetCellDiscr: ERROR: wrong kernel!" << Endl;
      result = -999.0;
   }

   return result;
}

//_____________________________________________________________________
void TMVA::PDEFoam::FillFoamCells(const Event* ev, Bool_t NoNegWeights)
{
   // This function fills an event into the foam.
   //
   // In case of Mono-Target regression this function prepares the
   // calculation of the average target value in every cell.  Note,
   // that only target 0 is saved in the cell!
   //
   // In case of a unified foam this function prepares the calculation of
   // the cell discriminator in every cell.
   //
   // If 'NoNegWeights' is true, an event with negative weight will
   // not be filled into the foam.  (Default value: false)

   std::vector<Float_t> values  = ev->GetValues();
   std::vector<Float_t> targets = ev->GetTargets();
   Float_t weight               = ev->GetOriginalWeight();
   EFoamType ft                 = GetFoamType();

   if((NoNegWeights && weight<=0) || weight==0)
      return;

   if (ft == kMultiTarget)
      values.insert(values.end(), targets.begin(), targets.end());

   // find corresponding foam cell
   PDEFoamCell *cell = FindCell(VarTransform(values));
   if (!cell) {
      Log() << kFATAL << "<PDEFoam::FillFoamCells>: No cell found!" << Endl;
      return;
   }

   // Add events to cell
   if (ft == kSeparate || ft == kMultiTarget){
      // 0. Element: Number of events
      // 1. Element: RMS
      SetCellElement(cell, 0, GetCellElement(cell, 0) + weight);
      SetCellElement(cell, 1, GetCellElement(cell, 1) + weight*weight);
   } else if (ft == kDiscr){
      // 0. Element: Number of signal events
      // 1. Element: Number of background events times normalization
      if (ev->IsSignal())
         SetCellElement(cell, 0, GetCellElement(cell, 0) + weight);
      else
         SetCellElement(cell, 1, GetCellElement(cell, 1) + weight);
   } else if (ft == kMonoTarget){
      // 0. Element: Number of events
      // 1. Element: Target 0
      SetCellElement(cell, 0, GetCellElement(cell, 0) + weight);
      SetCellElement(cell, 1, GetCellElement(cell, 1) + weight*targets.at(0));
   }
}

//_____________________________________________________________________
Double_t TMVA::PDEFoam::GetCellRegValue0( std::vector<Float_t> xvec, EKernel kernel )
{
   // Get regression value 0 from cell that contains xvec.
   // This function is used when the MultiTargetRegression==False option is set.

   Double_t result = 0.;

   std::vector<Float_t> txvec = VarTransform(xvec);
   PDEFoamCell *cell          = FindCell(txvec);

   if (!cell) {
      Log() << kFATAL << "<GetCellRegValue0> ERROR: No cell found!" << Endl;
      return -999.;
   }

   if (kernel == kNone){
      if (GetCellValue(cell, kTarget0Error)!=-1)
         // cell is not empty
         result = GetCellValue(cell, kTarget0);
      else
         // cell is empty -> calc average target of neighbor cells
         result = GetAverageNeighborsValue(txvec, kTarget0);
   } // kernel == kNone
   else if (kernel == kGaus){
      // return gaus weighted cell density

      Double_t norm = 0.;
      for (Long_t iCell=0; iCell<=fLastCe; iCell++) {
         if (!(fCells[iCell]->GetStat())) continue;

         // calc cell density
         Double_t cell_val = 0;
         if (GetCellValue(fCells[iCell], kTarget0Error) != -1)
            // cell is not empty
            cell_val = GetCellValue(fCells[iCell], kTarget0);
         else
            // cell is empty -> calc average target of neighbor cells
            cell_val = GetAverageNeighborsValue(txvec, kTarget0);
         Double_t gau = WeightGaus(fCells[iCell], txvec);

         result += gau * cell_val;
         norm   += gau;
      }
      result /= norm;
   }
   else if (kernel == kLinN) {
      if (GetCellValue(cell, kTarget0Error) != -1)
         // cell is not empty -> weight with non-empty neighbors
         result = WeightLinNeighbors(txvec, kTarget0, -1, -1, kTRUE);
      else
         // cell is empty -> calc average target of non-empty neighbor
         // cells
         result = GetAverageNeighborsValue(txvec, kTarget0);
   }
   else {
      Log() << kFATAL << "ERROR: unknown kernel!" << Endl;
      return -999.;
   }

   return result;
}

//_____________________________________________________________________
Double_t TMVA::PDEFoam::GetAverageNeighborsValue( std::vector<Float_t> txvec,
                                                  ECellValue cv )
{
   // This function returns the average value 'cv' of only nearest
   // neighbor cells.  It is used in cases, where empty cells shall
   // not be evaluated.
   //
   // Parameters:
   // - txvec - event vector, transformed into foam [0, 1]
   // - cv - cell value, see definition of ECellValue

   const Double_t xoffset = 1.e-6;
   Double_t norm   = 0; // normalisation
   Double_t result = 0; // return value

   PDEFoamCell *cell = FindCell(txvec); // find cooresponding cell
   PDEFoamVect cellSize(GetTotDim());
   PDEFoamVect cellPosi(GetTotDim());
   cell->GetHcub(cellPosi, cellSize); // get cell coordinates

   // loop over all dimensions and find neighbor cells
   for (Int_t dim=0; dim<GetTotDim(); dim++) {
      std::vector<Float_t> ntxvec = txvec;
      PDEFoamCell* left_cell  = 0; // left cell
      PDEFoamCell* right_cell = 0; // right cell

      // get left cell
      ntxvec[dim] = cellPosi[dim]-xoffset;
      left_cell = FindCell(ntxvec);
      if (!CellValueIsUndefined(left_cell)){
         // if left cell is not empty, take its value
         result += GetCellValue(left_cell, cv);
         norm++;
      }
      // get right cell
      ntxvec[dim] = cellPosi[dim]+cellSize[dim]+xoffset;
      right_cell = FindCell(ntxvec);
      if (!CellValueIsUndefined(right_cell)){
         // if right cell is not empty, take its value
         result += GetCellValue(right_cell, cv);
         norm++;
      }
   }
   if (norm>0)  result /= norm; // calc average target
   else         result = 0;     // return null if all neighbors are empty

   return result;
}

//_____________________________________________________________________
Bool_t TMVA::PDEFoam::CellValueIsUndefined( PDEFoamCell* cell )
{
   // Returns true, if the value of the given cell is undefined.

   EFoamType ft = GetFoamType();
   switch(ft){
   case kSeparate:
      return kFALSE;
      break;
   case kDiscr:
      return kFALSE;
      break;
   case kMonoTarget:
      return GetCellValue(cell, kTarget0Error) == -1;
      break;
   case kMultiTarget:
      return kFALSE;
      break;
   default:
      return kFALSE;
   }
}

//_____________________________________________________________________
std::vector<Float_t> TMVA::PDEFoam::GetCellTargets( std::vector<Float_t> tvals, ETargetSelection ts )
{
   // This function is used when the MultiTargetRegression==True
   // option is set.  It calculates the mean target or most probable
   // target values if 'tvals' variables are given ('tvals' does not
   // contain targets)
   //
   // Parameters:
   // - tvals - transformed event variables (element of [0,1]) (no targets!)
   // - ts - method of target selection (kMean, kMpv)
   //
   // Result:
   // vetor of mean targets or most probable targets over all cells
   // which first coordinates enclose 'tvals'

   std::vector<Float_t> target(GetTotDim()-tvals.size(), 0); // returned vector
   std::vector<Float_t> norm(target); // normalisation
   Double_t max_dens = 0.;            // maximum cell density

   // find cells, which fit tvals (no targets)
   std::vector<PDEFoamCell*> cells = FindCells(tvals);
   if (cells.size()<1) return target;

   // loop over all cells found
   std::vector<PDEFoamCell*>::iterator cell_it(cells.begin());
   for (cell_it=cells.begin(); cell_it!=cells.end(); cell_it++){

      // get density of cell
      Double_t cell_density = GetCellValue(*cell_it, kDensity);

      // get cell position and size
      PDEFoamVect  cellPosi(GetTotDim()), cellSize(GetTotDim());
      (*cell_it)->GetHcub(cellPosi, cellSize);

      // loop over all target dimensions, in order to calculate target
      // value
      if (ts==kMean){
         // sum cell density times cell center
         for (UInt_t itar=0; itar<target.size(); itar++){
            UInt_t idim = itar+tvals.size();
            target.at(itar) += cell_density *
               VarTransformInvers(idim, cellPosi[idim]+0.5*cellSize[idim]);
            norm.at(itar) += cell_density;
         } // loop over targets
      } else {
         // get cell center with maximum event density
         if (cell_density > max_dens){
            max_dens = cell_density; // save new max density
            // fill target values
            for (UInt_t itar=0; itar<target.size(); itar++){
               UInt_t idim = itar+tvals.size();
               target.at(itar) =
                  VarTransformInvers(idim, cellPosi[idim]+0.5*cellSize[idim]);
            } // loop over targets
         }
      }
   } // loop over cells

   // normalise mean cell density
   if (ts==kMean){
      for (UInt_t itar=0; itar<target.size(); itar++){
         if (norm.at(itar)>1.0e-15)
            target.at(itar) /= norm.at(itar);
         else
            // normalisation factor is too small -> return approximate
            // target value
            target.at(itar) = (fXmax[itar+tvals.size()]-fXmin[itar+tvals.size()])/2.;
      }
   }

   return target;
}

//_____________________________________________________________________
std::vector<Float_t> TMVA::PDEFoam::GetProjectedRegValue( std::vector<Float_t> vals, EKernel kernel, ETargetSelection ts )
{
   // This function is used when the MultiTargetRegression==True option is set.
   // Returns regression value i, given the event variables 'vals'.
   // Note: number of foam dimensions = number of variables + number of targets
   //
   // Parameters:
   // - vals - event variables (no targets)
   // - kernel - used kernel (None or Gaus)
   // - ts - method of target selection (Mean or Mpv)

   // checkt whether vals are within foam borders.
   // if not -> push it into foam
   const Float_t xsmall = 1.e-7;
   for (UInt_t l=0; l<vals.size(); l++) {
      if (vals.at(l) <= fXmin[l]){
         vals.at(l) = fXmin[l] + xsmall;
      }
      else if (vals.at(l) >= fXmax[l]){
         vals.at(l) = fXmax[l] - xsmall;
      }
   }

   // transform variables (vals)
   std::vector<Float_t> txvec = VarTransform(vals);
   std::vector<Float_t> target(GetTotDim()-txvec.size(), 0); // returned vector

   // choose kernel
   /////////////////// no kernel //////////////////
      if (kernel == kNone)
         return GetCellTargets(txvec, ts);
      ////////////////////// Gaus kernel //////////////////////
      else if (kernel == kGaus){

         std::vector<Float_t> norm(target); // normalisation

         // loop over all active cells to calc gaus weighted target values
         for (Long_t ice=0; ice<=fLastCe; ice++) {
            if (!(fCells[ice]->GetStat())) continue;

            // weight with gaus only in non-target dimensions!
            Double_t gau = WeightGaus(fCells[ice], txvec, vals.size());

            PDEFoamVect cellPosi(GetTotDim()), cellSize(GetTotDim());
            fCells[ice]->GetHcub(cellPosi, cellSize);

            // fill new vector with coordinates of new cell
            std::vector<Float_t> new_vec;
            for (UInt_t k=0; k<txvec.size(); k++)
               new_vec.push_back(cellPosi[k] + 0.5*cellSize[k]);

            std::vector<Float_t> val = GetCellTargets(new_vec, ts);
            for (UInt_t itar=0; itar<target.size(); itar++){
               target.at(itar) += gau * val.at(itar);
               norm.at(itar)   += gau;
            }
         }

         // normalisation
         for (UInt_t itar=0; itar<target.size(); itar++){
            if (norm.at(itar)<1.0e-20){
               Log() << kWARNING << "Warning: norm too small!" << Endl;
               target.at(itar) = 0.;
            } else
               target.at(itar) /= norm.at(itar);
         }

      } // end gaus kernel
      else {
         Log() << kFATAL << "<GetProjectedRegValue> ERROR: unsupported kernel!" << Endl;
         return std::vector<Float_t>(GetTotDim()-txvec.size(), 0);
      }

      return target;
}

//_____________________________________________________________________
Double_t TMVA::PDEFoam::GetCellDensity( std::vector<Float_t> xvec, EKernel kernel )
{
   // Returns density (=number of entries / volume) of cell that encloses 'xvec'.
   // This function is called by GetMvaValue() in case of two separated foams
   // (signal and background).
   // 'kernel' can be either kNone or kGaus.

   Double_t result = 0;
   std::vector<Float_t> txvec = VarTransform(xvec);
   PDEFoamCell *cell          = FindCell(txvec);

   if (!cell) {
      Log() << kFATAL << "<GetCellDensity(event)> ERROR: No cell found!" << Endl;
      return -999.;
   }

   if (kernel == kNone){
      // return cell entries over cell volume
      return GetCellValue(cell, kDensity);
   }
   else if (kernel == kGaus){
      // return gaus weighted cell density

      Double_t norm = 0.;

      for (Long_t iCell=0; iCell<=fLastCe; iCell++) {
         if (!(fCells[iCell]->GetStat())) continue;

         // calc cell density
         Double_t cell_dens = GetCellValue(fCells[iCell], kDensity);
         Double_t gau       = WeightGaus(fCells[iCell], txvec);

         result += gau * cell_dens;
         norm   += gau;
      }

      result /= norm;
   }
   else if (kernel == kLinN){
      result = WeightLinNeighbors(txvec, kDensity);
   }
   else {
      Log() << kFATAL << "<GetCellDensity(event)> ERROR: unknown kernel!" << Endl;
      return -999.;
   }

   return result;
}

//_____________________________________________________________________
Double_t TMVA::PDEFoam::GetCellValue( PDEFoamCell* cell, ECellValue cv )
{
   // This function returns a value, which was saved in the foam cell,
   // depending on the foam type.  The value to return is specified
   // with the 'cv' parameter.

   switch(cv){
      
   case kTarget0:
      if (GetFoamType() == kMonoTarget) return GetCellElement(cell, 0);
      break;

   case kTarget0Error:
      if (GetFoamType() == kMonoTarget) return GetCellElement(cell, 1);
      break;

   case kDiscriminator:
      if (GetFoamType() == kDiscr) return GetCellElement(cell, 0);
      break;

   case kDiscriminatorError:
      if (GetFoamType() == kDiscr) return GetCellElement(cell, 1);
      break;

   case kMeanValue:
      return cell->GetIntg();
      break;

   case kRms:
      return cell->GetDriv();
      break;

   case kRmsOvMean:
      if (cell->GetIntg() != 0) return cell->GetDriv()/cell->GetIntg();
      break;

   case kNev:
      if (GetFoamType() == kSeparate || GetFoamType() == kMultiTarget) 
         return GetCellElement(cell, 0);
      break;

   case kDensity: {
      
      Double_t volume  = cell->GetVolume();
      if ( volume > 1.0e-10 ){
         return GetCellValue(cell, kNev)/volume;
      } else {
         if (volume<=0){
            cell->Print("1"); // debug output
            Log() << kWARNING << "<GetCellDensity(cell)>: ERROR: cell volume"
                  << " negative or zero!"
                  << " ==> return cell density 0!"
                  << " cell volume=" << volume
                  << " cell entries=" << GetCellValue(cell, kNev) << Endl;
            return 0;
         } else
            Log() << kWARNING << "<GetCellDensity(cell)>: WARNING: cell volume"
                  << " close to zero!"
                  << " cell volume: " << volume << Endl;
      }
   } // kDensity
      
   default:
      return 0;
   }

   return 0;
}

//_____________________________________________________________________
Double_t TMVA::PDEFoam::GetCellValue(std::vector<Float_t> xvec, ECellValue cv)
{
   // This function finds the cell, which corresponds to the given
   // event vector 'xvec' and return its value, which is given by the
   // parameter 'cv'.
   
   return GetCellValue(FindCell(VarTransform(xvec)), cv);
}

//_____________________________________________________________________
Double_t TMVA::PDEFoam::GetBuildUpCellEvents( PDEFoamCell* cell )
{
   // Returns the number of events, saved in the 'cell' during foam build-up.
   // Only used during foam build-up!
   return GetCellElement(cell, 0);
}

//_____________________________________________________________________
Double_t TMVA::PDEFoam::WeightLinNeighbors( std::vector<Float_t> txvec, ECellValue cv, Int_t dim1, Int_t dim2, Bool_t TreatEmptyCells )
{
   // results the cell value, corresponding to txvec, weighted by the
   // neighor cells via a linear function
   //
   // Parameters
   //  - txvec - event vector, transformed to interval [0,1]
   //  - cv - cell value to be weighted
   //  - dim1, dim2 - dimensions for two-dimensional projection.
   //    Default values: dim1 = dim2 = -1
   //    If dim1 and dim2 are set to values >=0 and <fDim, than
   //    the function GetProjectionCellValue() is used to get cell
   //    value.  This is used for projection to two dimensions within
   //    Project2().
   //  - TreatEmptyCells - if this option is set false (default),
   //    it is not checked, wether the cell or its neighbors are empty
   //    or not.  If this option is set true, than only non-empty
   //    neighbor cells are taken into account for weighting.  If the
   //    cell, which contains txvec is empty, than its value is
   //    replaced by the average value of the non-empty neighbor cells

   Double_t result = 0.;
   UInt_t norm     = 0;
   const Double_t xoffset = 1.e-6;

   if (txvec.size() != UInt_t(GetTotDim()))
      Log() << kFATAL << "Wrong dimension of event variable!" << Endl;

   // find cell, which contains txvec
   PDEFoamCell *cell= FindCell(txvec);
   PDEFoamVect cellSize(GetTotDim());
   PDEFoamVect cellPosi(GetTotDim());
   cell->GetHcub(cellPosi, cellSize);
   // calc value of cell, which contains txvec
   Double_t cellval = 0;
   if (!(TreatEmptyCells && CellValueIsUndefined(cell)))
      // cell is not empty -> get cell value
      cellval = GetCellValue(cell, cv);
   else
      // cell is empty -> get average value of non-empty neighbor
      // cells
      cellval = GetAverageNeighborsValue(txvec, cv);

   // loop over all dimensions to find neighbor cells
   for (Int_t dim=0; dim<GetTotDim(); dim++) {
      std::vector<Float_t> ntxvec = txvec;
      Double_t mindist;
      PDEFoamCell *mindistcell = 0; // cell with minimal distance to txvec
      // calc minimal distance to neighbor cell
      mindist = (txvec[dim]-cellPosi[dim])/cellSize[dim];
      if (mindist<0.5) { // left neighbour
         ntxvec[dim] = cellPosi[dim]-xoffset;
         mindistcell = FindCell(ntxvec); // left neighbor cell
      } else { // right neighbour
         mindist=1-mindist;
         ntxvec[dim] = cellPosi[dim]+cellSize[dim]+xoffset;
         mindistcell = FindCell(ntxvec); // right neighbor cell
      }
      Double_t mindistcellval = 0; // value of cell, which contains ntxvec
      if (dim1>=0 && dim1<GetTotDim() &&
          dim2>=0 && dim2<GetTotDim() &&
          dim1!=dim2){
         cellval        = GetProjectionCellValue(cell, dim1, dim2, cv);
         mindistcellval = GetProjectionCellValue(mindistcell, dim1, dim2, cv);
      } else {
         mindistcellval = GetCellValue(mindistcell, cv);
      }
      // if treatment of empty neighbor cells is deactivated, do
      // normal weighting
      if (!(TreatEmptyCells && CellValueIsUndefined(mindistcell))){
         result += cellval        * (0.5 + mindist);
         result += mindistcellval * (0.5 - mindist);
         norm++;
      }
   }
   if (norm==0) return cellval;     // all nearest neighbors were empty
   else         return result/norm; // normalisation
}

//_____________________________________________________________________
Float_t TMVA::PDEFoam::WeightGaus( PDEFoamCell* cell, std::vector<Float_t> txvec,
                                   UInt_t dim )
{
   // Returns the gauss weight between the 'cell' and a given coordinate 'txvec'.
   //
   // Parameters:
   // - cell - the cell
   // - txvec - the transformed event variables (in [0,1]) (coordinates <0 are
   //   set to 0, >1 are set to 1)
   // - dim - number of dimensions for the calculation of the euclidean distance.
   //   If dim=0, all dimensions of the foam are taken.  Else only the first 'dim'
   //   coordinates of 'txvec' are used for the calculation of the euclidean distance.
   //
   // Returns:
   // exp(-(d/sigma)^2/2), where
   //  - d - is the euclidean distance between 'txvec' and the point of the 'cell'
   //    which is most close to 'txvec' (in order to avoid artefacts because of the
   //    form of the cells).
   //  - sigma = 1/VolFrac

   // get cell coordinates
   PDEFoamVect cellSize(GetTotDim());
   PDEFoamVect cellPosi(GetTotDim());
   cell->GetHcub(cellPosi, cellSize);

   // calc normalized distance
   UInt_t dims;            // number of dimensions for gaus weighting
   if (dim == 0)
      dims = GetTotDim();  // use all dimensions of cell txvec for weighting
   else if (dim <= UInt_t(GetTotDim()))
      dims = dim;          // use only 'dim' dimensions of cell txvec for weighting
   else {
      Log() << kFATAL << "ERROR: too many given dimensions for Gaus weight!" << Endl;
      return 0.;
   }

   // calc position of nearest edge of cell
   std::vector<Float_t> cell_center;
   for (UInt_t i=0; i<dims; i++){
      if (txvec[i]<0.) txvec[i]=0.;
      if (txvec[i]>1.) txvec[i]=1.;
      //cell_center.push_back(cellPosi[i] + (0.5*cellSize[i]));
      if (cellPosi[i] > txvec.at(i))
         cell_center.push_back(cellPosi[i]);
      else if (cellPosi[i]+cellSize[i] < txvec.at(i))
         cell_center.push_back(cellPosi[i]+cellSize[i]);
      else
         cell_center.push_back(txvec.at(i));
   }

   Float_t distance = 0.; // distance for weighting
   for (UInt_t i=0; i<dims; i++)
      distance += TMath::Power(txvec.at(i)-cell_center.at(i), 2);
   distance = TMath::Sqrt(distance);

   Float_t width = 1./GetPDEFoamVolumeFraction();
   if (width < 1.0e-10)
      Log() << kWARNING << "Warning: wrong volume fraction: " << GetPDEFoamVolumeFraction() << Endl;

   // weight with Gaus with sigma = 1/VolFrac
   return TMath::Gaus(distance, 0, width, kFALSE);
}

//_____________________________________________________________________
TMVA::PDEFoamCell* TMVA::PDEFoam::FindCell( std::vector<Float_t> xvec )
{
   // Find cell that contains xvec
   //
   // loop to find cell that contains xvec start from root Cell, uses
   // binary tree to find cell quickly

   PDEFoamVect  cellPosi0(GetTotDim()), cellSize0(GetTotDim());
   PDEFoamCell *cell, *cell0;

   cell=fCells[0]; // start with root cell
   Int_t idim=0;
   while (cell->GetStat()!=1) { //go down binary tree until cell is found
      idim=cell->GetBest();  // dimension that changed
      cell0=cell->GetDau0();
      cell0->GetHcub(cellPosi0,cellSize0);

      if (xvec.at(idim)<=cellPosi0[idim]+cellSize0[idim])
         cell=cell0;
      else
         cell=(cell->GetDau1());
   }
   return cell;
}

//_____________________________________________________________________
void TMVA::PDEFoam::FindCellsRecursive(std::vector<Float_t> txvec, PDEFoamCell* cell, std::vector<PDEFoamCell*> &cells)
{
   // This is a helper function for FindCells().  It saves in 'cells'
   // all cells, which contain txvec.  It works analogous to
   // FindCell().
   //
   // Parameters:
   //
   // - txvec - vector of variables (no targets!) (transformed into
   //   foam)
   //
   // - cell - cell to start searching with (usually root cell
   //   fCells[0])
   //
   // - cells - list of cells found

   PDEFoamVect  cellPosi0(GetTotDim()), cellSize0(GetTotDim());
   PDEFoamCell *cell0;
   Int_t idim=0;

   while (cell->GetStat()!=1) { //go down binary tree until cell is found
      idim=cell->GetBest();  // dimension that changed

      if (idim < Int_t(txvec.size())){
         // case 1: cell is splitten in dimension of a variable
         cell0=cell->GetDau0();
         cell0->GetHcub(cellPosi0,cellSize0);
         // check, whether left daughter cell contains txvec
         if (txvec.at(idim)<=cellPosi0[idim]+cellSize0[idim])
            cell=cell0;
         else
            cell=cell->GetDau1();
      } else {
         // case 2: cell is splitten in target dimension
         FindCellsRecursive(txvec, cell->GetDau0(), cells);
         FindCellsRecursive(txvec, cell->GetDau1(), cells);
         return;
      }
   }
   cells.push_back(cell);
}

//_____________________________________________________________________
std::vector<TMVA::PDEFoamCell*> TMVA::PDEFoam::FindCells(std::vector<Float_t> txvec)
{
   // Find all cells, that contain txvec.  This function can be used,
   // when the dimension of the foam is greater than the dimension of
   // txvec.  E.G this is the case for multi-target regression
   //
   // Parameters:
   //
   // - txvec - vector of variables (no targets!) (transformed into
   //   foam)
   //
   // Return value:
   //
   // - vector of cells, that fit txvec

   std::vector<PDEFoamCell*> cells(0);

   // loop over all target dimensions
   FindCellsRecursive(txvec, fCells[0], cells);

   return cells;
}

//_____________________________________________________________________
TH1D* TMVA::PDEFoam::Draw1Dim( const char *opt, Int_t nbin )
{
   // Draws 1-dimensional foam (= histogram)
   //
   // Parameters:
   //
   // - opt - cell_value, rms, rms_ov_mean
   //   if cell_value is set, the following values will be filled into
   //   the result histogram:
   //    - number of events - in case of classification with 2 separate
   //                         foams or multi-target regression
   //    - discriminator    - in case of classification with one
   //                         unified foam
   //    - target           - in case of mono-target regression
   //
   // - nbin - number of bins of result histogram
   //
   // Warning: This function is not well tested!

   // avoid plotting of wrong dimensions
   if ( GetTotDim()!=1 ) return 0;

   // select value to plot
   ECellValue cell_value = kNev;
   EFoamType  foam_type  = GetFoamType();
   if (strcmp(opt,"cell_value")==0){
      if (foam_type == kSeparate || foam_type == kMultiTarget){
         cell_value = kNev;
      } else if (foam_type == kDiscr){
         cell_value = kDiscriminator;
      } else if (foam_type == kMonoTarget){
         cell_value = kTarget0;
      } else {
         Log() << kFATAL << "unknown foam type" << Endl;
         return 0;
      }
   } else if (strcmp(opt,"rms")==0){
      cell_value = kRms;
   } else if (strcmp(opt,"rms_ov_mean")==0){
      cell_value = kRmsOvMean;
   } else {
      Log() << kFATAL << "<Draw1Dim>: unknown option:" << opt << Endl;
      return 0;
   }

   char hname[100]; char htit[100];
   sprintf(htit,"1-dimensional Foam: %s", opt);
   sprintf(hname,"h%s",opt);

   TH1D* h1=(TH1D*)gDirectory->Get(hname);
   if (h1) delete h1;
   h1= new TH1D(hname, htit, nbin, fXmin[0], fXmax[0]);

   if (!h1) Log() << kFATAL << "ERROR: Can not create histo" << hname << Endl;

   std::vector<Float_t> xvec(GetTotDim(), 0.);

   // loop over all bins
   for (Int_t ibinx=1; ibinx<=nbin; ibinx++) { //loop over  x-bins
      xvec.at(0) = h1->GetBinCenter(ibinx);

      // transform xvec
      std::vector<Float_t> txvec = VarTransform(xvec);

      // loop over all active cells
      for (Long_t iCell=0; iCell<=fLastCe; iCell++) {
         if (!(fCells[iCell]->GetStat())) continue; // cell not active -> continue

         // get cell position and dimesions
         PDEFoamVect  cellPosi(GetTotDim()), cellSize(GetTotDim());
         fCells[iCell]->GetHcub(cellPosi,cellSize);

         // compare them with txvec
         const Double_t xsmall = 1.e-10;
         if (!( (txvec.at(0)>cellPosi[0]-xsmall) &&
                (txvec.at(0)<=cellPosi[0]+cellSize[0]+xsmall) ) )
            continue;

         Double_t vol = fCells[iCell]->GetVolume();
         if (vol<1e-10) {
            Log() << kWARNING << "Project: ERROR: Volume too small!" << Endl;
            continue;
         }

         // filling value to histogram
         h1->SetBinContent(ibinx, 
                           GetCellValue(fCells[iCell], cell_value) + h1->GetBinContent(ibinx));
      }
   }
   return h1;
}

//_____________________________________________________________________
TH2D* TMVA::PDEFoam::Project2( Int_t idim1, Int_t idim2, const char *opt, const char *ker, UInt_t maxbins )
{
   // Project foam variable idim1 and variable idim2 to histogram.
   //
   // Parameters:
   //
   // - idim1, idim2 - dimensions to project to
   //
   // - opt - cell_value, rms, rms_ov_mean
   //   if cell_value is set, the following values will be filled into
   //   the result histogram:
   //    - number of events - in case of classification with 2 separate
   //                         foams or multi-target regression
   //    - discriminator    - in case of classification with one
   //                         unified foam
   //    - target           - in case of mono-target regression
   //
   // - ker - kGaus, kNone (warning: Gaus may be very slow!)
   //
   // - maxbins - maximal number of bins in result histogram.
   //   Set maxbins to 0 if no maximum bin number should be used.
   //
   // Returns:
   // a 2-dimensional histogram

   // avoid plotting of wrong dimensions
   if ((idim1>=GetTotDim()) || (idim1<0) ||
       (idim2>=GetTotDim()) || (idim2<0) ||
       (idim1==idim2) )
      return 0;

   // select value to plot
   ECellValue cell_value = kNev;
   EFoamType  foam_type  = GetFoamType();
   if (strcmp(opt,"cell_value")==0){
      if (foam_type == kSeparate || foam_type == kMultiTarget){
         cell_value = kNev;
      } else if (foam_type == kDiscr){
         cell_value = kDiscriminator;
      } else if (foam_type == kMonoTarget){
         cell_value = kTarget0;
      } else {
         Log() << kFATAL << "unknown foam type" << Endl;
         return 0;
      }
   } else if (strcmp(opt,"rms")==0){
      cell_value = kRms;
   } else if (strcmp(opt,"rms_ov_mean")==0){
      cell_value = kRmsOvMean;
   } else {
      Log() << kFATAL << "unknown option given" << Endl;
      return 0;
   }

   // select kernel to use
   EKernel kernel = kNone;
   if (!strcmp(ker, "kNone"))
      kernel = kNone;
   else if (!strcmp(ker, "kGaus"))
      kernel = kGaus;
   else if (!strcmp(ker, "kLinN"))
      kernel = kLinN;
   else
      Log() << kWARNING << "Warning: wrong kernel! using kNone instead" << Endl;

   Double_t bin_width = 1.; // minimal size of cell

   // loop over all cells to determine minimal cell size -> use for bin width
   for (Long_t iCell=0; iCell<=fLastCe; iCell++) { // loop over all active cells
      if (!(fCells[iCell]->GetStat())) continue;   // cell not active -> continue
      // get cell position and dimesions
      PDEFoamVect  cellPosi(GetTotDim()), cellSize(GetTotDim());
      fCells[iCell]->GetHcub(cellPosi,cellSize);
      // loop over all dimensions and determine minimal cell size
      for (Int_t d1=0; d1<GetTotDim(); d1++)
         if (cellSize[d1]<bin_width && cellSize[d1]>0)
            bin_width = cellSize[d1];
   }
   UInt_t nbin = UInt_t(1./bin_width);  // calculate number of bins

   if (maxbins>0 && nbin>maxbins) // limit maximum number of bins
      nbin = maxbins;

   // root can not handle too many bins in one histogram --> catch this
   // Furthermore, to have more than 1000 bins in the histogram doesn't make
   // sense.
   if (nbin>1000){
      Log() << kWARNING << "Warning: number of bins too big: " << nbin
            << " Using 1000 bins for each dimension instead." << Endl;
      nbin = 1000;
   }

   // create result histogram
   char hname[100], htit[100];
   sprintf(htit,"%s var%d vs var%d",opt,idim1,idim2);
   sprintf(hname,"h%s_%d_vs_%d",opt,idim1,idim2);

   // if histogram with this name already exists, delete it
   TH2D* h1=(TH2D*)gDirectory->Get(hname);
   if (h1) delete h1;
   h1= new TH2D(hname, htit, nbin, fXmin[idim1], fXmax[idim1], nbin, fXmin[idim2], fXmax[idim2]);

   if (!h1) Log() << kFATAL << "ERROR: Can not create histo" << hname << Endl;

   // ============== start projection algorithm ================
   // loop over all active cells
   for (Long_t iCell=0; iCell<=fLastCe; iCell++) { // loop over all active cells
      if (!(fCells[iCell]->GetStat())) continue;   // cell not active -> continue

      // get cell position and dimesions
      PDEFoamVect  cellPosi(GetTotDim()), cellSize(GetTotDim());
      fCells[iCell]->GetHcub(cellPosi,cellSize);

      // get cell value (depending on the option)
      // this value will later be filled into the histogram
      Double_t var = GetProjectionCellValue(fCells[iCell], idim1, idim2, cell_value);

      const Double_t xsmall = (1.e-20)*cellSize[idim1];
      const Double_t ysmall = (1.e-20)*cellSize[idim2];

      // coordinates of upper left corner of cell
      Double_t x1 = VarTransformInvers( idim1, cellPosi[idim1]+xsmall );
      Double_t y1 = VarTransformInvers( idim2, cellPosi[idim2]+ysmall );

      // coordinates of lower right corner of cell
      Double_t x2 = VarTransformInvers( idim1, cellPosi[idim1]+cellSize[idim1]-xsmall );
      Double_t y2 = VarTransformInvers( idim2, cellPosi[idim2]+cellSize[idim2]-ysmall );

      // most left and most right bins, which correspond to cell
      // borders
      Int_t xbin_start = h1->GetXaxis()->FindBin(x1);
      Int_t xbin_stop  = h1->GetXaxis()->FindBin(x2);

      // upper and lower bins, which correspond to cell borders
      Int_t ybin_start = h1->GetYaxis()->FindBin(y1);
      Int_t ybin_stop  = h1->GetYaxis()->FindBin(y2);

      // loop over all bins, which the cell occupies
      for (Int_t ibinx=xbin_start; ibinx<xbin_stop; ibinx++) {    //loop over x-bins
         for (Int_t ibiny=ybin_start; ibiny<ybin_stop; ibiny++) { //loop over y-bins

            ////////////////////// weight with kernel ///////////////////////
            if (kernel == kGaus){
               Double_t result = 0.;
               Double_t norm   = 0.;

               // calc current position (depending on ibinx, ibiny)
               Double_t x_curr =
                  VarTransform( idim1, ((x2-x1)*ibinx - x2*xbin_start + x1*xbin_stop)/(xbin_stop-xbin_start) );
               Double_t y_curr =
                  VarTransform( idim2, ((y2-y1)*ibiny - y2*ybin_start + y1*ybin_stop)/(ybin_stop-ybin_start) );

               // loop over all active cells
               for (Long_t ice=0; ice<=fLastCe; ice++) {
                  if (!(fCells[ice]->GetStat())) continue;

                  // get cell value (depending on option)
                  Double_t cell_var = GetProjectionCellValue(fCells[ice], idim1, idim2, cell_value);

                  // fill ndim coordinate of current cell
                  std::vector<Float_t> coor;
                  for (Int_t i=0; i<GetTotDim(); i++) {
                     if (i == idim1)
                        coor.push_back(x_curr);
                     else if (i == idim2)
                        coor.push_back(y_curr);
                     else
                        coor.push_back(cellPosi[i] + 0.5*cellSize[i]); // approximation
                  }

                  // calc weighted value
                  Double_t weight_ = WeightGaus(fCells[ice], coor);

                  result += weight_ * cell_var;
                  norm   += weight_;
               }
               var = result/norm;
            }
            else if (kernel == kLinN){
               // calc current position (depending on ibinx, ibiny)
               Double_t x_curr =
                  VarTransform( idim1, ((x2-x1)*ibinx - x2*xbin_start + x1*xbin_stop)/(xbin_stop-xbin_start) );
               Double_t y_curr =
                  VarTransform( idim2, ((y2-y1)*ibiny - y2*ybin_start + y1*ybin_stop)/(ybin_stop-ybin_start) );

               // fill ndim coordinate of current cell
               std::vector<Float_t> coor;
               for (Int_t i=0; i<GetTotDim(); i++) {
                  if (i == idim1)
                     coor.push_back(x_curr);
                  else if (i == idim2)
                     coor.push_back(y_curr);
                  else
                     coor.push_back(cellPosi[i] + 0.5*cellSize[i]); // approximation
               }

               var = WeightLinNeighbors(coor, cell_value, idim1, idim2);
            }
            ////////////////////// END weight with kernel ///////////////////////

            // filling value to histogram
            h1->SetBinContent(ibinx, ibiny, var + h1->GetBinContent(ibinx, ibiny));
         } // y-loop
      } // x-loop
   } // cell loop

   return h1;
}

//_____________________________________________________________________
Double_t TMVA::PDEFoam::GetProjectionCellValue( PDEFoamCell* cell,
                                                Int_t idim1,
                                                Int_t idim2,
                                                ECellValue cv )
{
   // Helper function for projection function Project2().  It returns
   // the cell value of 'cell' corresponding to the given option 'cv'.
   // The two dimensions are needed for weighting the return value,
   // because Project2() projects the foam to two dimensions.

   Double_t val = 0.; // return variable

   // get cell position and dimesions
   PDEFoamVect  cellPosi(GetTotDim()), cellSize(GetTotDim());
   cell->GetHcub(cellPosi,cellSize);
   const Double_t foam_area = (fXmax[idim1]-fXmin[idim1])*(fXmax[idim2]-fXmin[idim2]);

   // calculate cell value (depending on the given option 'cv')
   if (cv == kNev){
      // calculate projected area of cell
      Double_t area = cellSize[idim1] * cellSize[idim2];
      if (area<1e-20){
         Log() << kWARNING << "PDEFoam::Project2: Warning, cell volume too small --> skiping cell!" << Endl;
         return 0;
      }

      // calc cell entries per projected cell area
      val = GetCellValue(cell, kNev)/(area*foam_area);
   }
   // =========================================================
   else if (cv == kRms){
      val = GetCellValue(cell, kRms);
   }
   // =========================================================
   else if (cv == kRmsOvMean){
      val = GetCellValue(cell, kRmsOvMean);
   }
   // =========================================================
   else if (cv == kDiscriminator){
      // calculate cell volume in other dimensions (not including idim1 and idim2)
      Double_t area_cell = 1.;
      for (Int_t d1=0; d1<GetTotDim(); d1++){
         if ((d1!=idim1) && (d1!=idim2))
            area_cell *= cellSize[d1];
      }
      if (area_cell<1e-20){
         Log() << kWARNING << "PDEFoam::Project2: Warning, cell volume too small --> skiping cell!" << Endl;
         return 0;
      }

      // calc discriminator * (cell area times foam area)
      // foam is normalized -> length of foam = 1.0
      val = GetCellValue(cell, kDiscriminator)*area_cell;
   }
   // =========================================================
   else if (cv == kDiscriminatorError){
      // not testet jet!
      val = GetCellValue(cell, kDiscriminator);
   }
   // =========================================================
   else if (cv == kTarget0){
      // plot mean over all underlying cells?
      val = GetCellValue(cell, kTarget0);
   }
   else {
      Log() << kFATAL << "Project2: unknown option" << Endl;
      return 0;
   }

   return val;
}

//_____________________________________________________________________
TVectorD* TMVA::PDEFoam::GetCellElements( std::vector<Float_t> xvec )
{
   // Returns pointer to cell elements.  The given event vector 'xvec'
   // must be untransformed (i.e. [xmin, xmax]).

   assert(unsigned(GetTotDim()) == xvec.size());

   return dynamic_cast<TVectorD*>(FindCell(VarTransform(xvec))->GetElement());
}

//_____________________________________________________________________
Double_t TMVA::PDEFoam::GetCellElement( PDEFoamCell *cell, UInt_t i )
{
   // Returns cell element i of cell 'cell'.

   assert(i < GetNElements());

   return (*dynamic_cast<TVectorD*>(cell->GetElement()))(i);
}

//_____________________________________________________________________
void TMVA::PDEFoam::SetCellElement( PDEFoamCell *cell, UInt_t i, Double_t value )
{
   // Set cell element i of cell to value.

   if (i >= GetNElements()){
      Log() << kFATAL << "ERROR: Index out of range" << Endl;
      return;
   }

   TVectorD *vec = dynamic_cast<TVectorD*>(cell->GetElement());

   if (!vec)
      Log() << kFATAL << "<SetCellElement> ERROR: cell element is not a TVectorD*" << Endl;

   (*vec)(i) = value;
}

//_____________________________________________________________________
void TMVA::PDEFoam::OutputGrow( Bool_t finished )
{
   // Overridden function of PDEFoam to avoid native foam output.
   // Draw TMVA-process bar instead.

   if (finished) {
      Log() << kINFO << "Elapsed time: " + fTimer->GetElapsedTime()
            << "                                 " << Endl;
      return;
   }
   
   Int_t modulo = 1;

   if (fNCells        >= 100) modulo = Int_t(fNCells/100);
   if (fLastCe%modulo == 0)   fTimer->DrawProgressBar( fLastCe );
}

//_____________________________________________________________________
void TMVA::PDEFoam::RootPlot2dim( const TString& filename, std::string what,
                                  Bool_t CreateCanvas, Bool_t colors, Bool_t log_colors )
{
   // Debugging tool which plots 2-dimensional cells as rectangles
   // in C++ format readable for root.
   //
   // Parameters:
   // - filename - filename of ouput root macro
   // - CreateCanvas - whether to create a new canvas or not

   if (GetTotDim() != 2)
      Log() << kFATAL << "RootPlot2dim() can only be used with "
            << "two-dimensional foams!" << Endl;

   // select value to plot
   ECellValue cell_value = kNev;
   Bool_t plotcellnumber = kFALSE;
   Bool_t fillcells      = kTRUE;

   if (what == "mean")
      cell_value = kMeanValue;
   else if (what == "nevents")
      cell_value = kNev;
   else if (what == "density")
      cell_value = kDensity;
   else if (what == "rms")
      cell_value = kRms;
   else if (what == "rms_ov_mean")
      cell_value = kRmsOvMean;
   else if (what == "discr")
      cell_value = kDiscriminator;
   else if (what == "discrerr")
      cell_value = kDiscriminatorError;
   else if (what == "monotarget")
      cell_value = kTarget0;
   else if (what == "cellnumber")
      plotcellnumber = kTRUE;
   else if (what == "nofill") {
      plotcellnumber = kTRUE;
      fillcells = kFALSE;
   } else {
      cell_value = kMeanValue;
      Log() << kWARNING << "Unknown option, plotting mean!" << Endl;
   }

   std::ofstream outfile(filename, std::ios::out);
   Double_t x1,y1,x2,y2,x,y;
   Long_t   iCell;
   Double_t offs =0.01;
   Double_t lpag   =1-2*offs;

   outfile<<"{" << std::endl;

   if (!colors) { // define grayscale colors from light to dark,
      // starting from color index 1000
      outfile << "TColor *graycolors[100];" << std::endl;
      outfile << "for (Int_t i=0.; i<100; i++)" << std::endl;
      outfile << "  graycolors[i]=new TColor(1000+i, 1-(Float_t)i/100.,1-(Float_t)i/100.,1-(Float_t)i/100.);"<< std::endl;
   }
   if (CreateCanvas)
      outfile << "cMap = new TCanvas(\"" << fName << "\",\"Cell Map for "
              << fName << "\",600,600);" << std::endl;

   outfile<<"TBox*a=new TBox();"<<std::endl;
   outfile<<"a->SetFillStyle(0);"<<std::endl;  // big frame
   outfile<<"a->SetLineWidth(4);"<<std::endl;
   outfile<<"TBox *b1=new TBox();"<<std::endl;  // single cell
   if (fillcells) {
      outfile << (colors ? "gStyle->SetPalette(1, 0);" : "gStyle->SetPalette(0);") 
              << std::endl;
      outfile <<"b1->SetFillStyle(1001);"<<std::endl;
      outfile<<"TBox *b2=new TBox();"<<std::endl;  // single cell
      outfile <<"b2->SetFillStyle(0);"<<std::endl;
   }
   else {
      outfile <<"b1->SetFillStyle(0);"<<std::endl;
   }

   Int_t lastcell = fLastCe;

   if (fillcells)
      (colors ? gStyle->SetPalette(1, 0) : gStyle->SetPalette(0) );

   Double_t zmin = 1E8;  // minimal value (for color calculation)
   Double_t zmax = -1E8; // maximal value (for color calculation)

   Double_t value=0.;
   for (iCell=1; iCell<=lastcell; iCell++) {
      if ( fCells[iCell]->GetStat() == 1) {
         if (plotcellnumber)
            value = iCell;
         else
            value = GetCellValue(fCells[iCell], cell_value);
         if (value<zmin)
            zmin=value;
         if (value>zmax)
            zmax=value;
      }
   }
   outfile << "// observed minimum and maximum of distribution: " << std::endl;
   outfile << "// Double_t zmin = "<< zmin << ";" << std::endl;
   outfile << "// Double_t zmax = "<< zmax << ";" << std::endl;

   if (log_colors) {
      if (zmin<1)
         zmin=1;
      zmin=TMath::Log(zmin);
      zmax=TMath::Log(zmax);
      outfile << "// logarthmic color scale used " << std::endl;
   } else
      outfile << "// linear color scale used " << std::endl;

   outfile << "// used minimum and maximum of distribution (taking into account log scale if applicable): " << std::endl;
   outfile << "Double_t zmin = "<< zmin << ";" << std::endl;
   outfile << "Double_t zmax = "<< zmax << ";" << std::endl;

   // Next lines from THistPainter.cxx

   Int_t ncolors  = colors ? gStyle->GetNumberOfColors() : 100;
   Double_t dz    = zmax - zmin;
   Double_t scale = (ncolors-1)/dz;

   PDEFoamVect  cellPosi(GetTotDim()); PDEFoamVect  cellSize(GetTotDim());
   outfile << "// =========== Rectangular cells  ==========="<< std::endl;
   for (iCell=1; iCell<=lastcell; iCell++) {
      if ( fCells[iCell]->GetStat() == 1) {
         fCells[iCell]->GetHcub(cellPosi,cellSize);
         x1 = offs+lpag*(cellPosi[0]);             
         y1 = offs+lpag*(cellPosi[1]);
         x2 = offs+lpag*(cellPosi[0]+cellSize[0]); 
         y2 = offs+lpag*(cellPosi[1]+cellSize[1]);
         
         value = 0;
         if (fillcells) {
            if (plotcellnumber) 
               value = iCell;
            else 
               value = GetCellValue(fCells[iCell], cell_value);

            if (log_colors) {
               if (value<1.) value=1;
               value = TMath::Log(value);
            }

            Int_t color;
            if (colors)
               color = gStyle->GetColorPalette(Int_t((value-zmin)*scale));
            else
               color = 1000+(Int_t((value-zmin)*scale));

            outfile << "b1->SetFillColor(" << color << ");" << std::endl;
         }

         //     cell rectangle
         outfile<<"b1->DrawBox("<<x1<<","<<y1<<","<<x2<<","<<y2<<");"<<std::endl;
         if (fillcells)
            outfile<<"b2->DrawBox("<<x1<<","<<y1<<","<<x2<<","<<y2<<");"<<std::endl;

         //     cell number
         if (lastcell<=250) {
            x = offs+lpag*(cellPosi[0]+0.5*cellSize[0]); 
            y = offs+lpag*(cellPosi[1]+0.5*cellSize[1]);
         }
      }
   }
   outfile<<"// ============== End Rectangles ==========="<< std::endl;

   outfile << "}" << std::endl;
   outfile.flush();
   outfile.close();
}

//_____________________________________________________________________
void TMVA::PDEFoam::SetVolumeFraction( Double_t vfr )
{
   // set VolFrac to internal foam density PDEFoamDistr
   fDistr->SetVolumeFraction(vfr);
   SetPDEFoamVolumeFraction(vfr);
}

//_____________________________________________________________________
void TMVA::PDEFoam::FillBinarySearchTree( const Event* ev, Bool_t NoNegWeights )
{
   // Insert event to internal foam density PDEFoamDistr.
   fDistr->FillBinarySearchTree(ev, GetFoamType(), NoNegWeights);
}

//_____________________________________________________________________
void TMVA::PDEFoam::Init()
{
   // Initialize internal foam density PDEFoamDistr
   fDistr->Initialize(GetTotDim());
}

//_____________________________________________________________________
void TMVA::PDEFoam::SetFoamType( EFoamType ft )
{
   // Set the foam type.  This determinates the method of the
   // calculation of the density during the foam build-up.
   if (ft==kDiscr)
      fDistr->SetDensityCalc(kDISCRIMINATOR);
   else if (ft==kMonoTarget)
      fDistr->SetDensityCalc(kTARGET);
   else
      fDistr->SetDensityCalc(kEVENT_DENSITY);

   fFoamType = ft; // set foam type class variable
}

//_____________________________________________________________________
ostream& TMVA::operator<< ( ostream& os, const TMVA::PDEFoam& pdefoam )
{
   // Write PDEFoam variables to stream 'os'.
   pdefoam.PrintStream(os);
   return os; // Return the output stream.
}

//_____________________________________________________________________
istream& TMVA::operator>> ( istream& istr, TMVA::PDEFoam& pdefoam )
{
   // Read PDEFoam variables from stream 'istr'.
   pdefoam.ReadStream(istr);
   return istr;
}

//_____________________________________________________________________
void TMVA::PDEFoam::ReadStream( istream & istr )
{
   // Read PDEFoam variables from stream 'istr'.

   // inherited class variables: fLastCe, fNCells, fDim[GetTotDim()]
   istr >> fLastCe;
   istr >> fNCells;
   istr >> fDim;


   Double_t vfr = -1.;
   istr >> vfr;
   SetPDEFoamVolumeFraction(vfr);

   Log() << kVERBOSE << "Foam dimension: " << GetTotDim() << Endl;

   // read Class Variables: fXmin, fXmax
   if (fXmin) delete [] fXmin;
   if (fXmax) delete [] fXmax;
   fXmin = new Double_t[GetTotDim()];
   fXmax = new Double_t[GetTotDim()];
   for (Int_t i=0; i<GetTotDim(); i++)
      istr >> fXmin[i];
   for (Int_t i=0; i<GetTotDim(); i++)
      istr >> fXmax[i];
}

//_____________________________________________________________________
void TMVA::PDEFoam::PrintStream( ostream & ostr ) const
{
   // Write PDEFoam variables to stream 'os'.

   // inherited class variables: fLastCe, fNCells, fDim[GetTotDim()]
   ostr << fLastCe << std::endl;
   ostr << fNCells << std::endl;
   ostr << fDim    << std::endl;
   ostr << GetPDEFoamVolumeFraction() << std::endl;

   // write class variables: fXmin, fXmax
   for (Int_t i=0; i<GetTotDim(); i++)
      ostr << fXmin[i] << std::endl;
   for (Int_t i=0; i<GetTotDim(); i++)
      ostr << fXmax[i] << std::endl;
}

//_____________________________________________________________________
void TMVA::PDEFoam::AddXMLTo( void* parent ){
   // write foam variables to xml

   void *variables = gTools().xmlengine().NewChild( parent, 0, "Variables" );
   gTools().AddAttr( variables, "LastCe",           fLastCe );
   gTools().AddAttr( variables, "nCells",           fNCells );
   gTools().AddAttr( variables, "Dim",              fDim );
   gTools().AddAttr( variables, "VolumeFraction",   GetPDEFoamVolumeFraction() );

   void *xmin_wrap;
   for (Int_t i=0; i<GetTotDim(); i++){
      xmin_wrap = gTools().xmlengine().NewChild( variables, 0, "Xmin" );
      gTools().AddAttr( xmin_wrap, "Index", i );
      gTools().AddAttr( xmin_wrap, "Value", fXmin[i] );
   }

   void *xmax_wrap;
   for (Int_t i=0; i<GetTotDim(); i++){
      xmax_wrap = gTools().xmlengine().NewChild( variables, 0, "Xmax" );
      gTools().AddAttr( xmax_wrap, "Index", i );
      gTools().AddAttr( xmax_wrap, "Value", fXmax[i] );
   }
}

//_____________________________________________________________________
void TMVA::PDEFoam::ReadXML( void* parent ) {
   void *variables = gTools().xmlengine().GetChild( parent );
   gTools().ReadAttr( variables, "LastCe",         fLastCe );
   gTools().ReadAttr( variables, "nCells",         fNCells );
   gTools().ReadAttr( variables, "Dim",            fDim );
   Float_t volfr;
   gTools().ReadAttr( variables, "VolumeFraction", volfr );
   SetPDEFoamVolumeFraction( volfr );

   if (fXmin) delete [] fXmin;
   if (fXmax) delete [] fXmax;
   fXmin = new Double_t[GetTotDim()];
   fXmax = new Double_t[GetTotDim()];

   void *xmin_wrap = gTools().xmlengine().GetChild( variables );
   for (Int_t counter=0; counter<fDim; counter++) {
      Int_t i=0;
      gTools().ReadAttr( xmin_wrap , "Index", i );
      if (i >= GetTotDim() || i<0)
         Log() << kFATAL << "dimension index out of range:" << i << Endl;
      gTools().ReadAttr( xmin_wrap , "Value", fXmin[i] );
      xmin_wrap = gTools().xmlengine().GetNext( xmin_wrap );
   }

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