Classes | Public Member Functions | Static Public Member Functions | Public Attributes | Static Public Attributes | Private Member Functions | Static Private Member Functions | Private Attributes
pcl::poisson::Octree< Degree > Class Template Reference

#include <multi_grid_octree_data.h>

List of all members.

Classes

class  AdjacencyCountFunction
class  AdjacencySetFunction
class  FaceEdgesFunction
struct  PointData
struct  PointInfo
class  RefineFunction
struct  RootData
struct  Stencil

Public Member Functions

void ClipTree (void)
void finalize (void)
Real GetIsoValue (void)
void GetMCIsoTriangles (Real isoValue, int subdivideDepth, pcl::poisson::CoredMeshData *mesh, int fullDepthIso=0, int nonLinearFit=1, bool addBarycenter=false, bool polygonMesh=false)
RealGetSolutionGrid (int &res, float isoValue=0.f, int depth=-1)
RealGetWeightGrid (int &res, int depth=-1)
int LaplacianMatrixIteration (int subdivideDepth, bool showResidual, int minIters, double accuracy)
 Octree (void)
void RefineBoundary (int subdivisionDepth)
void setBSplineData (int maxDepth, Real normalSmooth=-1, bool reflectBoundary=false)
void SetLaplacianConstraints (void)
template<typename PointNT >
int setTree (boost::shared_ptr< const pcl::PointCloud< PointNT > > input_, int maxDepth, int minDepth, int kernelDepth, Real samplesPerNode, Real scaleFactor, Point3D< Real > &center, Real &scale, int useConfidence, Real constraintWeight, bool adaptiveWeights)

Static Public Member Functions

static double MemoryUsage (void)

Public Attributes

pcl::poisson::BSplineData
< Degree, BSplineDataReal
fData
std::vector
< pcl::poisson::Point3D< Real > > * 
normals
Real postNormalSmooth
int threads
TreeOctNode tree

Static Public Attributes

static double maxMemoryUsage = 0

Private Member Functions

template<class C >
void DownSample (int depth, const SortedTreeNodes &sNodes, C *constraints) const
void DownSampleFinerConstraints (int depth, SortedTreeNodes &sNodes) const
Real getCenterValue (const TreeOctNode::ConstNeighborKey3 &neighborKey3, const TreeOctNode *node)
pcl::poisson::Point3D< RealgetCornerNormal (const TreeOctNode::ConstNeighborKey5 &neighborKey5, const TreeOctNode *node, int corner, const Real *metSolution)
Real getCornerValue (const TreeOctNode::ConstNeighborKey3 &neighborKey3, const TreeOctNode *node, int corner, const Real *metSolution)
Real getCornerValue (const TreeOctNode::ConstNeighborKey3 &neighborKey3, const TreeOctNode *node, int corner, const Real *metSolution, const double stencil1[3][3][3], const double stencil2[3][3][3])
Real GetDivergence (const TreeOctNode *node1, const TreeOctNode *node2, const pcl::poisson::Point3D< Real > &normal1) const
Real GetDivergenceMinusLaplacian (const TreeOctNode *node1, const TreeOctNode *node2, Real value1, const pcl::poisson::Point3D< Real > &normal1) const
int GetFixedDepthLaplacian (pcl::poisson::SparseSymmetricMatrix< float > &matrix, int depth, const SortedTreeNodes &sNodes, Real *subConstraints)
Real GetLaplacian (const int index[DIMENSION]) const
Real GetLaplacian (const TreeOctNode *node1, const TreeOctNode *node2) const
int GetMatrixRowSize (const TreeOctNode::Neighbors5 &neighbors5) const
int GetMatrixRowSize (const TreeOctNode::Neighbors5 &neighbors5, int xStart, int xEnd, int yStart, int yEnd, int zStart, int zEnd) const
void GetMCIsoEdges (TreeOctNode *node, int sDepth, std::vector< std::pair< RootInfo, RootInfo > > &edges)
int GetMCIsoTriangles (TreeOctNode *node, pcl::poisson::CoredMeshData *mesh, RootData &rootData, std::vector< pcl::poisson::Point3D< float > > *interiorPositions, int offSet, int sDepth, bool polygonMesh, std::vector< pcl::poisson::Point3D< float > > *barycenters)
int GetRestrictedFixedDepthLaplacian (pcl::poisson::SparseSymmetricMatrix< float > &matrix, int depth, const int *entries, int entryCount, const TreeOctNode *rNode, Real radius, const SortedTreeNodes &sNodes, Real *subConstraints)
int GetRoot (const RootInfo &ri, Real isoValue, TreeOctNode::ConstNeighborKey5 &neighborKey5, pcl::poisson::Point3D< Real > &position, RootData &rootData, int sDepth, const Real *metSolution, int nonLinearFit)
Real GetValue (const PointInfo points[3][3][3], const bool hasPoints[3][3], const int d[3]) const
int HasNormals (TreeOctNode *node, Real epsilon)
void NonLinearGetSampleDepthAndWeight (TreeOctNode *node, const pcl::poisson::Point3D< Real > &position, Real samplesPerNode, Real &depth, Real &weight)
Real NonLinearGetSampleWeight (TreeOctNode *node, const pcl::poisson::Point3D< Real > &position)
int NonLinearSplatOrientedPoint (TreeOctNode *node, const pcl::poisson::Point3D< Real > &point, const pcl::poisson::Point3D< Real > &normal)
Real NonLinearSplatOrientedPoint (const pcl::poisson::Point3D< Real > &point, const pcl::poisson::Point3D< Real > &normal, int kernelDepth, Real samplesPerNode, int minDepth, int maxDepth)
int NonLinearUpdateWeightContribution (TreeOctNode *node, const pcl::poisson::Point3D< Real > &position, Real weight=Real(1.0))
int SetBoundaryMCRootPositions (int sDepth, Real isoValue, RootData &rootData, pcl::poisson::CoredMeshData *mesh, int nonLinearFit)
void SetCoarserPointValues (int depth, const SortedTreeNodes &sNodes, Real *metSolution)
void SetDivergenceStencil (int depth, pcl::poisson::Point3D< double > *stencil, bool scatter) const
void SetDivergenceStencils (int depth, Stencil< pcl::poisson::Point3D< double >, 5 > stencil[2][2][2], bool scatter) const
void SetEvaluationStencils (int depth, Stencil< double, 3 > stencil1[8], Stencil< double, 3 > stencil2[8][8]) const
void SetIsoCorners (Real isoValue, TreeOctNode *leaf, SortedTreeNodes::CornerTableData &cData, char *valuesSet, Real *values, TreeOctNode::ConstNeighborKey3 &nKey, const Real *metSolution, const Stencil< double, 3 > stencil1[8], const Stencil< double, 3 > stencil2[8][8])
void SetLaplacianStencil (int depth, double stencil[5][5][5]) const
void SetLaplacianStencils (int depth, Stencil< double, 5 > stencil[2][2][2]) const
int SetMatrixRow (const TreeOctNode::Neighbors5 &neighbors5, pcl::poisson::MatrixEntry< float > *row, int offset, const double stencil[5][5][5]) const
int SetMatrixRow (const TreeOctNode::Neighbors5 &neighbors5, pcl::poisson::MatrixEntry< float > *row, int offset, const double stencil[5][5][5], int xStart, int xEnd, int yStart, int yEnd, int zStart, int zEnd) const
void SetMatrixRowBounds (const TreeOctNode *node, int rDepth, const int rOff[3], int &xStart, int &xEnd, int &yStart, int &yEnd, int &zStart, int &zEnd) const
int SetMCRootPositions (TreeOctNode *node, int sDepth, Real isoValue, TreeOctNode::ConstNeighborKey5 &neighborKey5, RootData &rootData, std::vector< pcl::poisson::Point3D< float > > *interiorPositions, pcl::poisson::CoredMeshData *mesh, const Real *metSolution, int nonLinearFit)
int SolveFixedDepthMatrix (int depth, const SortedTreeNodes &sNodes, Real *subConstraints, bool showResidual, int minIters, double accuracy)
int SolveFixedDepthMatrix (int depth, const SortedTreeNodes &sNodes, Real *subConstraints, int startingDepth, bool showResidual, int minIters, double accuracy)
void UpdateConstraintsFromCoarser (const TreeOctNode::NeighborKey5 &neighborKey5, TreeOctNode *node, Real *metSolution, const Stencil< double, 5 > &stencil) const
template<class C >
void UpSample (int depth, const SortedTreeNodes &sNodes, C *coefficients) const
void UpSampleCoarserSolution (int depth, const SortedTreeNodes &sNodes, pcl::poisson::Vector< Real > &solution) const
Real WeightedCoarserFunctionValue (const TreeOctNode::NeighborKey3 &neighborKey3, const TreeOctNode *node, Real *metSolution) const

Static Private Member Functions

static int AddTriangles (pcl::poisson::CoredMeshData *mesh, std::vector< pcl::poisson::CoredPointIndex > &edges, std::vector< pcl::poisson::Point3D< float > > *interiorPositions, int offSet, bool polygonMesh, std::vector< pcl::poisson::Point3D< float > > *barycenters)
static int EdgeRootCount (const TreeOctNode *node, int edgeIndex, int maxDepth)
static int GetEdgeLoops (std::vector< std::pair< RootInfo, RootInfo > > &edges, std::vector< std::vector< std::pair< RootInfo, RootInfo > > > &loops)
static int GetRootIndex (const TreeOctNode *node, int edgeIndex, int maxDepth, RootInfo &ri)
static int GetRootIndex (const TreeOctNode *node, int edgeIndex, int maxDepth, int sDepth, RootInfo &ri)
static int GetRootIndex (const RootInfo &ri, RootData &rootData, pcl::poisson::CoredPointIndex &index)
static int GetRootPair (const RootInfo &root, int maxDepth, RootInfo &pair)
static void GetRootSpan (const RootInfo &ri, pcl::poisson::Point3D< float > &start, pcl::poisson::Point3D< float > &end)
static int InteriorFaceRootCount (const TreeOctNode *node, const int &faceIndex, int maxDepth)
static int IsBoundaryEdge (const TreeOctNode *node, int edgeIndex, int subdivideDepth)
static int IsBoundaryEdge (const TreeOctNode *node, int dir, int x, int y, int subidivideDepth)
static int IsBoundaryFace (const TreeOctNode *node, int faceIndex, int subdivideDepth)
static void UpdateCoarserSupportBounds (const TreeOctNode *node, int &startX, int &endX, int &startY, int &endY, int &startZ, int &endZ)

Private Attributes

bool _constrainValues
int _minDepth
std::vector< int > _pointCount
std::vector< PointData_points
SortedTreeNodes _sNodes
TreeOctNode::NeighborKey3 neighborKey
TreeOctNode::ConstNeighborKey3 neighborKey2
Real radius
int width

Detailed Description

template<int Degree>
class pcl::poisson::Octree< Degree >

Definition at line 195 of file multi_grid_octree_data.h.


Constructor & Destructor Documentation

template<int Degree>
pcl::poisson::Octree< Degree >::Octree ( void  )

Definition at line 507 of file multi_grid_octree_data.hpp.


Member Function Documentation

template<int Degree>
int pcl::poisson::Octree< Degree >::AddTriangles ( pcl::poisson::CoredMeshData mesh,
std::vector< pcl::poisson::CoredPointIndex > &  edges,
std::vector< pcl::poisson::Point3D< float > > *  interiorPositions,
int  offSet,
bool  polygonMesh,
std::vector< pcl::poisson::Point3D< float > > *  barycenters 
) [static, private]

Definition at line 3633 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::ClipTree ( void  )

Definition at line 2084 of file multi_grid_octree_data.hpp.

template<int Degree>
template<class C >
void pcl::poisson::Octree< Degree >::DownSample ( int  depth,
const SortedTreeNodes sNodes,
C constraints 
) const [private]

Definition at line 1597 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::DownSampleFinerConstraints ( int  depth,
SortedTreeNodes sNodes 
) const [private]

Definition at line 1532 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::EdgeRootCount ( const TreeOctNode node,
int  edgeIndex,
int  maxDepth 
) [static, private]

Definition at line 2896 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::finalize ( void  )

Definition at line 969 of file multi_grid_octree_data.hpp.

template<int Degree>
Real pcl::poisson::Octree< Degree >::getCenterValue ( const TreeOctNode::ConstNeighborKey3 &  neighborKey3,
const TreeOctNode node 
) [private]

Definition at line 2578 of file multi_grid_octree_data.hpp.

template<int Degree>
Point3D< Real > pcl::poisson::Octree< Degree >::getCornerNormal ( const TreeOctNode::ConstNeighborKey5 &  neighborKey5,
const TreeOctNode node,
int  corner,
const Real metSolution 
) [private]

Definition at line 2719 of file multi_grid_octree_data.hpp.

template<int Degree>
Real pcl::poisson::Octree< Degree >::getCornerValue ( const TreeOctNode::ConstNeighborKey3 &  neighborKey3,
const TreeOctNode node,
int  corner,
const Real metSolution 
) [private]
template<int Degree>
Real pcl::poisson::Octree< Degree >::getCornerValue ( const TreeOctNode::ConstNeighborKey3 &  neighborKey3,
const TreeOctNode node,
int  corner,
const Real metSolution,
const double  stencil1[3][3][3],
const double  stencil2[3][3][3] 
) [private]
template<int Degree>
Real pcl::poisson::Octree< Degree >::GetDivergence ( const TreeOctNode node1,
const TreeOctNode node2,
const pcl::poisson::Point3D< Real > &  normal1 
) const [private]

Definition at line 1028 of file multi_grid_octree_data.hpp.

template<int Degree>
Real pcl::poisson::Octree< Degree >::GetDivergenceMinusLaplacian ( const TreeOctNode node1,
const TreeOctNode node2,
Real  value1,
const pcl::poisson::Point3D< Real > &  normal1 
) const [private]

Definition at line 1058 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::GetEdgeLoops ( std::vector< std::pair< RootInfo, RootInfo > > &  edges,
std::vector< std::vector< std::pair< RootInfo, RootInfo > > > &  loops 
) [static, private]

Definition at line 3583 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::GetFixedDepthLaplacian ( pcl::poisson::SparseSymmetricMatrix< float > &  matrix,
int  depth,
const SortedTreeNodes sNodes,
Real subConstraints 
) [private]

Definition at line 1764 of file multi_grid_octree_data.hpp.

template<int Degree>
Real pcl::poisson::Octree< Degree >::GetIsoValue ( void  )

Definition at line 2770 of file multi_grid_octree_data.hpp.

template<int Degree>
Real pcl::poisson::Octree< Degree >::GetLaplacian ( const int  index[DIMENSION]) const [private]

Definition at line 1012 of file multi_grid_octree_data.hpp.

template<int Degree>
Real pcl::poisson::Octree< Degree >::GetLaplacian ( const TreeOctNode node1,
const TreeOctNode node2 
) const [private]

Definition at line 1017 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::GetMatrixRowSize ( const TreeOctNode::Neighbors5 &  neighbors5) const [private]
template<int Degree>
int pcl::poisson::Octree< Degree >::GetMatrixRowSize ( const TreeOctNode::Neighbors5 &  neighbors5,
int  xStart,
int  xEnd,
int  yStart,
int  yEnd,
int  zStart,
int  zEnd 
) const [private]
template<int Degree>
void pcl::poisson::Octree< Degree >::GetMCIsoEdges ( TreeOctNode node,
int  sDepth,
std::vector< std::pair< RootInfo, RootInfo > > &  edges 
) [private]

Definition at line 3448 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::GetMCIsoTriangles ( TreeOctNode node,
pcl::poisson::CoredMeshData mesh,
RootData rootData,
std::vector< pcl::poisson::Point3D< float > > *  interiorPositions,
int  offSet,
int  sDepth,
bool  polygonMesh,
std::vector< pcl::poisson::Point3D< float > > *  barycenters 
) [private]
template<int Degree>
void pcl::poisson::Octree< Degree >::GetMCIsoTriangles ( Real  isoValue,
int  subdivideDepth,
pcl::poisson::CoredMeshData mesh,
int  fullDepthIso = 0,
int  nonLinearFit = 1,
bool  addBarycenter = false,
bool  polygonMesh = false 
)

Definition at line 2407 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::GetRestrictedFixedDepthLaplacian ( pcl::poisson::SparseSymmetricMatrix< float > &  matrix,
int  depth,
const int *  entries,
int  entryCount,
const TreeOctNode rNode,
Real  radius,
const SortedTreeNodes sNodes,
Real subConstraints 
) [private]

Definition at line 1808 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::GetRoot ( const RootInfo ri,
Real  isoValue,
TreeOctNode::ConstNeighborKey5 &  neighborKey5,
pcl::poisson::Point3D< Real > &  position,
RootData rootData,
int  sDepth,
const Real metSolution,
int  nonLinearFit 
) [private]

Definition at line 3010 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::GetRootIndex ( const TreeOctNode node,
int  edgeIndex,
int  maxDepth,
RootInfo ri 
) [static, private]

Definition at line 3221 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::GetRootIndex ( const TreeOctNode node,
int  edgeIndex,
int  maxDepth,
int  sDepth,
RootInfo ri 
) [static, private]

Definition at line 3140 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::GetRootIndex ( const RootInfo ri,
RootData rootData,
pcl::poisson::CoredPointIndex index 
) [static, private]

Definition at line 3316 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::GetRootPair ( const RootInfo root,
int  maxDepth,
RootInfo pair 
) [static, private]

Definition at line 3299 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::GetRootSpan ( const RootInfo ri,
pcl::poisson::Point3D< float > &  start,
pcl::poisson::Point3D< float > &  end 
) [static, private]

Definition at line 2976 of file multi_grid_octree_data.hpp.

template<int Degree>
Real * pcl::poisson::Octree< Degree >::GetSolutionGrid ( int &  res,
float  isoValue = 0.f,
int  depth = -1 
)

Definition at line 3752 of file multi_grid_octree_data.hpp.

template<int Degree>
Real pcl::poisson::Octree< Degree >::GetValue ( const PointInfo  points[3][3][3],
const bool  hasPoints[3][3],
const int  d[3] 
) const [private]

Definition at line 994 of file multi_grid_octree_data.hpp.

template<int Degree>
Real * pcl::poisson::Octree< Degree >::GetWeightGrid ( int &  res,
int  depth = -1 
)

Definition at line 3796 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::HasNormals ( TreeOctNode node,
Real  epsilon 
) [private]

Definition at line 2075 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::InteriorFaceRootCount ( const TreeOctNode node,
const int &  faceIndex,
int  maxDepth 
) [static, private]

Definition at line 2852 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::IsBoundaryEdge ( const TreeOctNode node,
int  edgeIndex,
int  subdivideDepth 
) [static, private]

Definition at line 2943 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::IsBoundaryEdge ( const TreeOctNode node,
int  dir,
int  x,
int  y,
int  subidivideDepth 
) [static, private]

Definition at line 2949 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::IsBoundaryFace ( const TreeOctNode node,
int  faceIndex,
int  subdivideDepth 
) [static, private]

Definition at line 2931 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::LaplacianMatrixIteration ( int  subdivideDepth,
bool  showResidual,
int  minIters,
double  accuracy 
)

Definition at line 1865 of file multi_grid_octree_data.hpp.

template<int Degree>
double pcl::poisson::Octree< Degree >::MemoryUsage ( void  ) [static]

Definition at line 500 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::NonLinearGetSampleDepthAndWeight ( TreeOctNode node,
const pcl::poisson::Point3D< Real > &  position,
Real  samplesPerNode,
Real depth,
Real weight 
) [private]

Definition at line 658 of file multi_grid_octree_data.hpp.

template<int Degree>
Real pcl::poisson::Octree< Degree >::NonLinearGetSampleWeight ( TreeOctNode node,
const pcl::poisson::Point3D< Real > &  position 
) [private]

Definition at line 678 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::NonLinearSplatOrientedPoint ( TreeOctNode node,
const pcl::poisson::Point3D< Real > &  point,
const pcl::poisson::Point3D< Real > &  normal 
) [private]

Definition at line 517 of file multi_grid_octree_data.hpp.

template<int Degree>
Real pcl::poisson::Octree< Degree >::NonLinearSplatOrientedPoint ( const pcl::poisson::Point3D< Real > &  point,
const pcl::poisson::Point3D< Real > &  normal,
int  kernelDepth,
Real  samplesPerNode,
int  minDepth,
int  maxDepth 
) [private]

Definition at line 580 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::NonLinearUpdateWeightContribution ( TreeOctNode node,
const pcl::poisson::Point3D< Real > &  position,
Real  weight = Real(1.0) 
) [private]

Definition at line 709 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::RefineBoundary ( int  subdivisionDepth)

Definition at line 2340 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::SetBoundaryMCRootPositions ( int  sDepth,
Real  isoValue,
RootData rootData,
pcl::poisson::CoredMeshData mesh,
int  nonLinearFit 
) [private]

Definition at line 3407 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::setBSplineData ( int  maxDepth,
Real  normalSmooth = -1,
bool  reflectBoundary = false 
)

Definition at line 960 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::SetCoarserPointValues ( int  depth,
const SortedTreeNodes sNodes,
Real metSolution 
) [private]

Definition at line 1710 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::SetDivergenceStencil ( int  depth,
pcl::poisson::Point3D< double > *  stencil,
bool  scatter 
) const [private]

Definition at line 1209 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::SetDivergenceStencils ( int  depth,
Stencil< pcl::poisson::Point3D< double >, 5 >  stencil[2][2][2],
bool  scatter 
) const [private]

Definition at line 1311 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::SetEvaluationStencils ( int  depth,
Stencil< double, 3 >  stencil1[8],
Stencil< double, 3 >  stencil2[8][8] 
) const [private]

Definition at line 1363 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::SetIsoCorners ( Real  isoValue,
TreeOctNode leaf,
SortedTreeNodes::CornerTableData cData,
char *  valuesSet,
Real values,
TreeOctNode::ConstNeighborKey3 &  nKey,
const Real metSolution,
const Stencil< double, 3 >  stencil1[8],
const Stencil< double, 3 >  stencil2[8][8] 
) [private]

Definition at line 2800 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::SetLaplacianConstraints ( void  )

Definition at line 2097 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::SetLaplacianStencil ( int  depth,
double  stencil[5][5][5] 
) const [private]

Definition at line 1267 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::SetLaplacianStencils ( int  depth,
Stencil< double, 5 >  stencil[2][2][2] 
) const [private]

Definition at line 1287 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::SetMatrixRow ( const TreeOctNode::Neighbors5 &  neighbors5,
pcl::poisson::MatrixEntry< float > *  row,
int  offset,
const double  stencil[5][5][5] 
) const [private]
template<int Degree>
int pcl::poisson::Octree< Degree >::SetMatrixRow ( const TreeOctNode::Neighbors5 &  neighbors5,
pcl::poisson::MatrixEntry< float > *  row,
int  offset,
const double  stencil[5][5][5],
int  xStart,
int  xEnd,
int  yStart,
int  yEnd,
int  zStart,
int  zEnd 
) const [private]
template<int Degree>
void pcl::poisson::Octree< Degree >::SetMatrixRowBounds ( const TreeOctNode node,
int  rDepth,
const int  rOff[3],
int &  xStart,
int &  xEnd,
int &  yStart,
int &  yEnd,
int &  zStart,
int &  zEnd 
) const [private]

Definition at line 1094 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::SetMCRootPositions ( TreeOctNode node,
int  sDepth,
Real  isoValue,
TreeOctNode::ConstNeighborKey5 &  neighborKey5,
RootData rootData,
std::vector< pcl::poisson::Point3D< float > > *  interiorPositions,
pcl::poisson::CoredMeshData mesh,
const Real metSolution,
int  nonLinearFit 
) [private]

Definition at line 3340 of file multi_grid_octree_data.hpp.

template<int Degree>
template<typename PointNT >
int pcl::poisson::Octree< Degree >::setTree ( boost::shared_ptr< const pcl::PointCloud< PointNT > >  input_,
int  maxDepth,
int  minDepth,
int  kernelDepth,
Real  samplesPerNode,
Real  scaleFactor,
Point3D< Real > &  center,
Real scale,
int  useConfidence,
Real  constraintWeight,
bool  adaptiveWeights 
)

Definition at line 742 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::SolveFixedDepthMatrix ( int  depth,
const SortedTreeNodes sNodes,
Real subConstraints,
bool  showResidual,
int  minIters,
double  accuracy 
) [private]

Definition at line 1888 of file multi_grid_octree_data.hpp.

template<int Degree>
int pcl::poisson::Octree< Degree >::SolveFixedDepthMatrix ( int  depth,
const SortedTreeNodes sNodes,
Real subConstraints,
int  startingDepth,
bool  showResidual,
int  minIters,
double  accuracy 
) [private]

Definition at line 1945 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::UpdateCoarserSupportBounds ( const TreeOctNode node,
int &  startX,
int &  endX,
int &  startY,
int &  endY,
int &  startZ,
int &  endZ 
) [static, private]

Definition at line 1404 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::UpdateConstraintsFromCoarser ( const TreeOctNode::NeighborKey5 &  neighborKey5,
TreeOctNode node,
Real metSolution,
const Stencil< double, 5 > &  stencil 
) const [private]

Definition at line 1420 of file multi_grid_octree_data.hpp.

template<int Degree>
template<class C >
void pcl::poisson::Octree< Degree >::UpSample ( int  depth,
const SortedTreeNodes sNodes,
C coefficients 
) const [private]

Definition at line 1656 of file multi_grid_octree_data.hpp.

template<int Degree>
void pcl::poisson::Octree< Degree >::UpSampleCoarserSolution ( int  depth,
const SortedTreeNodes sNodes,
pcl::poisson::Vector< Real > &  solution 
) const [private]

Definition at line 1480 of file multi_grid_octree_data.hpp.

template<int Degree>
Real pcl::poisson::Octree< Degree >::WeightedCoarserFunctionValue ( const TreeOctNode::NeighborKey3 &  neighborKey3,
const TreeOctNode node,
Real metSolution 
) const [private]

Definition at line 1731 of file multi_grid_octree_data.hpp.


Member Data Documentation

template<int Degree>
bool pcl::poisson::Octree< Degree >::_constrainValues [private]

Definition at line 199 of file multi_grid_octree_data.h.

template<int Degree>
int pcl::poisson::Octree< Degree >::_minDepth [private]

Definition at line 198 of file multi_grid_octree_data.h.

template<int Degree>
std::vector< int > pcl::poisson::Octree< Degree >::_pointCount [private]

Definition at line 200 of file multi_grid_octree_data.h.

template<int Degree>
std::vector< PointData > pcl::poisson::Octree< Degree >::_points [private]

Definition at line 208 of file multi_grid_octree_data.h.

template<int Degree>
SortedTreeNodes pcl::poisson::Octree< Degree >::_sNodes [private]

Definition at line 197 of file multi_grid_octree_data.h.

template<int Degree>
pcl::poisson::BSplineData<Degree,BSplineDataReal> pcl::poisson::Octree< Degree >::fData

Definition at line 341 of file multi_grid_octree_data.h.

template<int Degree>
double pcl::poisson::Octree< Degree >::maxMemoryUsage = 0 [static]

Definition at line 336 of file multi_grid_octree_data.h.

template<int Degree>
TreeOctNode::NeighborKey3 pcl::poisson::Octree< Degree >::neighborKey [private]

Definition at line 209 of file multi_grid_octree_data.h.

template<int Degree>
TreeOctNode::ConstNeighborKey3 pcl::poisson::Octree< Degree >::neighborKey2 [private]

Definition at line 210 of file multi_grid_octree_data.h.

template<int Degree>
std::vector< pcl::poisson::Point3D<Real> >* pcl::poisson::Octree< Degree >::normals

Definition at line 338 of file multi_grid_octree_data.h.

template<int Degree>
Real pcl::poisson::Octree< Degree >::postNormalSmooth

Definition at line 339 of file multi_grid_octree_data.h.

template<int Degree>
Real pcl::poisson::Octree< Degree >::radius [private]

Definition at line 212 of file multi_grid_octree_data.h.

template<int Degree>
int pcl::poisson::Octree< Degree >::threads

Definition at line 335 of file multi_grid_octree_data.h.

template<int Degree>
TreeOctNode pcl::poisson::Octree< Degree >::tree

Definition at line 340 of file multi_grid_octree_data.h.

template<int Degree>
int pcl::poisson::Octree< Degree >::width [private]

Definition at line 213 of file multi_grid_octree_data.h.


The documentation for this class was generated from the following files:


pcl
Author(s): Open Perception
autogenerated on Wed Aug 26 2015 15:44:33