|
BucketMap< Void > * | downPath (const BucketMap< T > ®ion, const Point3d &pos) |
|
template BucketMap< Void > * | downPath (const BucketMap< float > ®ion, const Point3d &pos) |
|
float | fiberDistance (FiberPoint *f1, FiberPoint *f2, int &fiberSize1, int &fiberSize2) |
|
float | fiberDistanceMax (FiberPoint *f1, FiberPoint *f2, int &fiberSize1, int &fiberSize2) |
|
float | fiberDistance (std::vector< Point3df > &f1, std::vector< Point3df > &f2) |
|
float | fiberDistanceMax (std::vector< Point3df > &f1, std::vector< Point3df > &f2) |
|
float | getClosestFiberPointDist (Point3df &p1, FiberPoint *f2, Point3df &pMin, int &fiberSize2) |
|
float | getClosestFiberPointDist (Point3df &p1, std::vector< Point3df > &f2, Point3df &pMin) |
|
float | fiberDistanceMaxDistCorrespPoints (FiberPoint *f1, FiberPoint *f2, int &fiberSize1) |
|
float | fiberDistanceMaxDistCorrespPoints (std::vector< Point3df > &f1, std::vector< Point3df > &f2) |
|
float | calculateMinFibersLength (FiberPoint *f1, FiberPoint *f2, int &fiberSize1, int &fiberSize2) |
|
float | calculateMinFibersLength (std::vector< Point3df > &f1, std::vector< Point3df > &f2) |
|
float | fiberDistanceMaxDistCorrespPointsNormByMinLength (FiberPoint *f1, FiberPoint *f2, float normFactor, int &fiberSize1, int &fiberSize2) |
|
float | fiberDistanceMaxDistCorrespPointsNormByMinLength (std::vector< Point3df > &f1, std::vector< Point3df > &f2, float normFactor) |
|
float | fiberAffinity (std::vector< Point3df > &f1, std::vector< Point3df > &f2, float var) |
|
float | fiberAffinityMax (std::vector< Point3df > &f1, std::vector< Point3df > &f2, float var) |
|
float | fiberAffinityMaxDistCorrespPoints (std::vector< Point3df > &f1, std::vector< Point3df > &f2, float var) |
|
float | fiberAffinityMaxDistCorrespPointsNormByMinLength (std::vector< Point3df > &f1, std::vector< Point3df > &f2, float var, float normFactor) |
|
float | fiberAffinity (FiberPoint *f1, FiberPoint *f2, float var, int &fiberSize1, int &fiberSize2) |
|
float | fiberAffinityMax (FiberPoint *f1, FiberPoint *f2, float var, int &fiberSize1, int &fiberSize2) |
|
float | fiberAffinityMaxDistCorrespPoints (FiberPoint *f1, FiberPoint *f2, float var, int &fiberSize1, int &fiberSize2) |
|
float | fiberAffinityMaxDistCorrespPointsNormByMinLength (FiberPoint *f1, FiberPoint *f2, float var, float normFactor, int &fiberSize1, int &fiberSize2) |
|
RoiSelectorReader & | operator>> (RoiSelectorReader &, Tree &) |
|
RoiSelectorReader & | operator>> (RoiSelectorReader &reader, RoiSelector &thing) |
|
RoiGtmReader & | operator>> (RoiGtmReader &, RoiGtm &) |
|
void | makeLaplacianMatrix (const LaplacianWeights &weights, LaplacianWeights &lmat, float dt) |
|
LaplacianWeights * | sparseMult (const LaplacianWeights &in1, const LaplacianWeights &in2, float sparseThresh=0) |
|
void | applyLaplacianMatrix (const std::vector< T > &inittex, std::vector< T > &outtex, const LaplacianWeights &lapl) |
|
void | laplacianMatrixThreshold (LaplacianWeights &lmat, float threshold) |
|
LaplacianWeights * | makeLaplacianSmoothingCoefficients (const LaplacianWeights &weights, unsigned niter, float dt, float sparseThresh=0) |
|
void | distancesFromMesh (const AimsSurfaceTriangle &mesh, std::vector< AimsVector< uint, 2 > > &edges, std::vector< double > &weights) |
|
int | meshWatershed (const AimsSurfaceTriangle &mesh, const std::vector< double > &field, std::vector< int > &idx, std::vector< int > &depth, std::vector< int > &major, std::vector< int > &label, double threshold) |
|
int | meshWatershed (const AimsSurfaceTriangle &mesh, const TimeTexture< double > &field, TimeTexture< int > &idx, TimeTexture< int > &depth, TimeTexture< int > &major, TimeTexture< int > &label, double threshold) |
|
int | meshBlobsBifurcation (const AimsSurfaceTriangle &mesh, const std::vector< double > &field, std::vector< int > &idx, std::vector< double > &height, std::vector< int > &father, std::vector< int > &label, double th) |
|
int | meshBlobsBifurcation (const AimsSurfaceTriangle &mesh, const TimeTexture< double > &field, TimeTexture< int > &idx, TimeTexture< double > &height, TimeTexture< int > &father, TimeTexture< int > &label, double th) |
|
void | blobsHeights (const AimsSurfaceTriangle &mesh, const std::vector< double > &field, const std::vector< int > &watershedlabels, std::vector< int > &junctions) |
|
AimsData< short > * | GetSSBlobImage (PrimalSketch< AimsData< T >, AimsData< T > > *sketch) |
|
TimeTexture< float > | GetSSBlobTexture (PrimalSketch< AimsSurface< D, Void >, Texture< T > > *sketch) |
|
AimsSurfaceTriangle * | GetSSBlobMesh (PrimalSketch< AimsSurface< D, Void >, Texture< T > > *sketch) |
|
AimsBucket< Void > * | GetSSBlobBucket (PrimalSketch< AimsData< T >, AimsData< T > > *sketch) |
|
AimsSurfaceTriangle * | GetSSBlobTore (PrimalSketch< AimsSurface< D, Void >, Texture< T > > *sketch) |
|
void | AddBlobsToPSGraph (PrimalSketch< Geom, Text > *sketch, Graph *graph) |
|
void | AddBlobsToPSGraph (PrimalSketch< AimsData< T >, AimsData< T > > *sketch, Graph *graph) |
|
void | AddBlobsToPSGraph (PrimalSketch< AimsSurface< D, Void >, Texture< T > > *sketch, Graph *graph) |
|
AimsSurfaceTriangle * | GetSSBlobMesh (PrimalSketch< AimsSurface< D, Void >, Texture< T > > *sketch, AimsSurfaceTriangle *mesh) |
|
AimsBucket< Void > * | GetSSBlobMeshBucket (AimsSurfaceTriangle *mesh) |
|
SplinePyramid | buildSplinePyramid (const carto::VolumeRef< T > &vol, unsigned order, unsigned factor=2) |
|
SplinePyramid | buildSplinePyramid (const carto::VolumeRef< T > &vol, unsigned order, const Point4du &factor) |
|
SplinePyramid | buildSplinePyramid (const carto::VolumeRef< T > &vol, unsigned order, const std::vector< Point4du > &factor) |
|
SplinePyramid | cubicSplinePyramid (const carto::VolumeRef< T > &vol, unsigned factor=2) |
|
SplinePyramid | cubicSplinePyramid (const carto::VolumeRef< T > &vol, const Point4du &factor) |
|
SplinePyramid | cubicSplinePyramid (const carto::VolumeRef< T > &vol, const std::vector< Point4du > &factor) |
|
class | __attribute__ ((__deprecated__)) MaskLinearResampler |
|
int | mirrorCoeff (int i, int size) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (MedianFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (MedianFilterFunc, AimsRGBA) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (NotNullMedianFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (NotNullMedianFilterFunc, AimsRGBA) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (MeanFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (MeanFilterFunc, AimsRGBA) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (NotNullMeanFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (NotNullMeanFilterFunc, AimsRGBA) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (MinFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (MinFilterFunc, AimsRGBA) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (MaxFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (MaxFilterFunc, AimsRGBA) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (MajorityFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (MajorityFilterFunc, AimsRGBA) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (ExtremaDifferenceFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (ExtremaDifferenceFilterFunc, AimsRGBA) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (SumFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (SumFilterFunc, AimsRGBA) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (VarFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (VarFilterFunc, AimsRGBA) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (StDevFilterFunc, AimsRGB) |
|
| AIMS_ELEMENT_FILTERFUNC_MULTICHANNEL_DECLARE (StDevFilterFunc, AimsRGBA) |
|
VoxelType | multichannelfiltervalues_nonlin (const ElementFilteringFunction< typename VoxelType::ChannelType > &f, const carto::VolumeRef< VoxelType > &volume) |
|
VoxelType | multichannelfiltervalues_nonlin (const ElementFilteringFunction< typename VoxelType::ChannelType > &f, const carto::VolumeRef< VoxelType > &volume, const carto::rc_ptr< StructuringElement > &se) |
|
void | setKernel () |
|
| AIMS_LIN_FILTERFUNC_MULTICHANNEL_DECLARE (GaborFilterFunc, AimsRGB) |
|
| AIMS_LIN_FILTERFUNC_MULTICHANNEL_DECLARE (GaborFilterFunc, AimsRGBA) |
|
VoxelType | multichannelfiltervalues_lin (const LinearFilteringFunction< typename VoxelType::ChannelType > &f, const carto::VolumeRef< VoxelType > &volume) |
|
void | transformMesh (AimsTimeSurface< D, Void > &mesh, const soma::Transformation3d &direct_transformation) |
|
carto::rc_ptr< BucketMap< Void > > | transformBucketDirect (const BucketMap< Void > &bck, const soma::Transformation3d &direct_transformation, Point3df vs=Point3df(0., 0., 0.)) |
|
carto::rc_ptr< BucketMap< Void > > | resampleBucket (const BucketMap< Void > &bck, const soma::Transformation3d &direct_transformation, const soma::Transformation3d &inverse_transformation, Point3df vs=Point3df(0., 0., 0.), bool also_pushforward=true) |
|
void | transformGraph (Graph &graph, const soma::Transformation3d &direct_transformation, const soma::Transformation3d *inverse_transformation, Point3df vs=Point3df(0., 0., 0.)) |
|
void | transformMesh (AimsTimeSurface< D, Void > &mesh, const Transformation3d &direct_transformation) |
|
carto::VolumeRef< T > | clipDynamic (const carto::VolumeRef< T > &in, bool flatten_mask=true, float pct_kept=1.) |
|
carto::VolumeRef< T > | clipDynamic (carto::VolumeRef< T > &in, bool flatten_mask=true, float pct_kept=1., bool in_place=true) |
|
carto::VolumeRef< T > | clip (const carto::VolumeRef< T > &in, const T &min, const T &max) |
|
carto::VolumeRef< T > | clip (carto::VolumeRef< T > &in, const T &min, const T &max, bool in_place=false) |
|
void | AimsConnectedComponent (AimsData< T > &data, aims::Connectivity::Type connectivity, std::map< T, size_t > &valids, const T &backgrnd=0, bool bin=true, size_t minSize=0, size_t maxSize=0, size_t numMax=0, bool verbose=true) |
|
void | AimsConnectedComponent (AimsData< T > &data, aims::Connectivity::Type connectivity, const T &backgrnd=0, bool bin=true, size_t minSize=0, size_t maxSize=0, size_t numMax=0, bool verbose=true) |
|
void | AimsConnectedComponent (BucketMap< T > &data, aims::Connectivity::Type connectivity, const T &backgrnd=0, bool bin=true, size_t minSize=0, size_t maxSize=0, size_t numMax=0, bool verbose=true) |
|
void | AimsConnectedComponent (AimsBucket< Void > &component, const AimsData< T > &data, aims::Connectivity::Type connectivity, const T &backgrnd=0, bool bin=true, size_t minsize=0, size_t maxSize=0, size_t maxcomp=0, bool verbose=true) |
|
void | AimsConnectedComponent (AimsBucket< Void > &component, const BucketMap< T > &data, Connectivity::Type connectivity, const T &backgrnd=0, bool bin=true, size_t minsize=0, size_t maxSize=0, size_t maxcomp=0, bool verbose=true) |
|
AimsData< int16_t > | AimsLabeledConnectedComponent (AimsBucket< Void > &component, const AimsData< T > &data, aims::Connectivity::Type connectivity, const T &backgrnd=0, bool bin=true, size_t minsize=0, size_t maxSize=0, size_t maxcomp=0, bool verbose=true) |
|
AimsData< T > | diag (const AimsData< T > &thing) |
|
AimsData< T > | undiag (const AimsData< T > &thing) |
|
AimsData< T > | transpose (const AimsData< T > &thing) |
|
void | incSorting (AimsData< T > &thing) |
|
void | decSorting (AimsData< T > &thing) |
|
AimsData< int32_t > | incOrder (const AimsData< T > &thing) |
|
AimsData< int32_t > | decOrder (const AimsData< T > &thing) |
|
bool | hasSameDim (const AimsData< T > &v1, const AimsData< T > &v2) |
|
bool | hasSameSize (const AimsData< T > &v1, const AimsData< T > &v2) |
|
AimsData< T > | triInf (const AimsData< T > &thing) |
|
AimsData< T > | triSup (const AimsData< T > &thing) |
|
std::string | aimsVersion () |
|
AIMSDATA_API T | byteswap (const T &x) |
|
AIMSDATA_API T | byteswap16 (const T &x) |
|
AIMSDATA_API T | byteswap32 (const T &x) |
|
AIMSDATA_API T | byteswap64 (const T &x) |
|
AIMSDATA_API short | byteswap (const short &x) |
|
AIMSDATA_API unsigned short | byteswap (const unsigned short &x) |
|
AIMSDATA_API int | byteswap (const int &x) |
|
AIMSDATA_API unsigned int | byteswap (unsigned int x) |
|
AIMSDATA_API float | byteswap (const float &x) |
|
GenesisReader< T > & | operator>> (GenesisReader< T > &reader, AimsData< T > &thing) |
|
AIMSDATA_API HierarchyReader & | operator>> (HierarchyReader &, Tree &) |
|
HierarchyReader & | operator>> (HierarchyReader &reader, Hierarchy &thing) |
|
MotionWriter & | operator<< (MotionWriter &writer, const AffineTransformation3d &thing) __attribute__((__deprecated__("OBSOLETE"))) |
|
AIMSDATA_API PovWriter< D, T > & | operator<< (PovWriter< D, T > &writer, const AimsTimeSurface< D, T > &thing) |
|
bool | canEncodeAsScaledS16 (const carto::Volume< T > &vol, float &slope, float &offset, bool enableoffset=true, double *maxerr=0) |
|
bool | canEncodeAsScaledS16 (const carto::Volume< float > &vol, float &slope, float &offset, bool enableoffset, double *) |
|
bool | canEncodeAsScaledS16 (const carto::Volume< double > &vol, float &slope, float &offset, bool enableoffset, double *) |
|
SpmReader< T > & | operator>> (SpmReader< T > &reader, AimsData< T > &thing) |
|
SpmWriter< T > & | operator<< (SpmWriter< T > &writer, const AimsData< T > &thing) |
|
void | spmAttributesConverter (carto::Object header) |
|
void | spmAttributesConverter (carto::GenericObject &header) |
|
aims::GenericWriter & | operator<< (aims::GenericWriter &writer, const T &thing) |
|
aims::Writer< T > & | operator<< (aims::Writer< T > &writer, const T &thing) |
|
AIMSDATA_API MeshReader< D, T > & | operator>> (MeshReader< D, T > &reader, AimsTimeSurface< D, T > &thing) |
|
AIMSDATA_API MeshWriter< D, T > & | operator<< (MeshWriter< D, T > &writer, const AimsTimeSurface< D, T > &thing) |
|
TriReader & | operator>> (TriReader &reader, AimsSurfaceTriangle &thing) |
|
TriWriter & | operator<< (TriWriter &writer, AimsSurfaceTriangle &thing) |
|
AIMSDATA_API TexReader< T > & | operator>> (TexReader< T > &r, TimeTexture< T > &thing) |
|
AIMSDATA_API ItemWriter< T > & | operator>> (ItemWriter< T > &w, TimeTexture< T > &thing) |
|
WavefrontMeshWriter< D, T > & | operator<< (WavefrontMeshWriter< D, T > &writer, const AimsTimeSurface< D, T > &thing) |
|
WavefrontMeshReader< D, T > & | operator>> (WavefrontMeshReader< D, T > &reader, AimsTimeSurface< D, T > &thing) |
|
int | textureMax (const TimeTexture< short > &intex) |
|
int | textureMin (const TimeTexture< short > &intex) |
|
std::map< short, size_t > * | labelsHistogram (const TimeTexture< short > &intex, int maxlabel=32767, int minlabel=-32768, bool verbose=false) |
|
carto::VolumeRef< AimsRGBA > | giftiColormap (const carto::Object header) |
|
carto::VolumeRef< AimsRGBA > | giftiColormap (const TimeTexture< T > &texture) |
|
BucketMap< Void > * | mask (const BucketMap< Void > &src, const BucketMap< Void > &m, bool intersect=true) |
|
BucketMap< Void > * | maskWithVolume (const BucketMap< Void > &src, const carto::rc_ptr< carto::Volume< T > > m, const T &val=0, bool insideval=false) |
|
carto::rc_ptr< Interpolator > | getLinearInterpolator (const std::string &) |
|
carto::rc_ptr< Interpolator > | getLinearInterpolator (const AimsData< T > &) |
|
template carto::rc_ptr< Interpolator > | getLinearInterpolator (const AimsData< uint8_t > &) |
|
template carto::rc_ptr< Interpolator > | getLinearInterpolator (const AimsData< int8_t > &) |
|
template carto::rc_ptr< Interpolator > | getLinearInterpolator (const AimsData< uint16_t > &) |
|
template carto::rc_ptr< Interpolator > | getLinearInterpolator (const AimsData< int16_t > &) |
|
template carto::rc_ptr< Interpolator > | getLinearInterpolator (const AimsData< short > &) |
|
template carto::rc_ptr< Interpolator > | getLinearInterpolator (const AimsData< uint32_t > &) |
|
template carto::rc_ptr< Interpolator > | getLinearInterpolator (const AimsData< int32_t > &) |
|
template carto::rc_ptr< Interpolator > | getLinearInterpolator (const AimsData< float > &) |
|
template carto::rc_ptr< Interpolator > | getLinearInterpolator (const AimsData< double > &) |
|
Quaternion | operator* (const Quaternion &a, const Quaternion &b) |
|
void | floodFill (carto::Volume< T > &vol, const Point3d &pos, T value, Connectivity::Type connectivity=Connectivity::CONNECTIVITY_18_XYZ, T tolerence=0, bool verbose=false) |
|
carto::rc_ptr< MaskIterator > | getMaskIterator (const std::string &fileName) |
|
carto::rc_ptr< MaskIterator > | getMaskIterator (const std::string &fileName, carto::rc_ptr< VoxelSampler > voxelSampler) |
|
carto::rc_ptr< MaskIterator > | getMaskIterator (const AimsData< T > &data) |
|
carto::rc_ptr< MaskIterator > | getMaskIterator (const AimsData< T > &data, carto::rc_ptr< VoxelSampler > voxelSampler) |
|
carto::rc_ptr< MaskIterator > | getMaskIterator (const std::string &fileName, const Motion &motion) |
|
carto::rc_ptr< MaskIterator > | getMaskIterator (const std::string &fileName, carto::rc_ptr< VoxelSampler > voxelSampler, const Motion &motion) |
|
carto::rc_ptr< MaskIterator > | getMaskIterator (const AimsData< T > &data, const Motion &motion) |
|
carto::rc_ptr< MaskIterator > | getMaskIterator (const AimsData< T > &data, carto::rc_ptr< VoxelSampler > voxelSampler, const Motion &motion) |
|
carto::rc_ptr< RoiIterator > | getRoiIterator (const std::string &fileName, carto::rc_ptr< VoxelSampler > voxelSampler=carto::rc_ptr< VoxelSampler >()) |
|
carto::rc_ptr< RoiIterator > | getRoiIterator (const AimsData< T > &data, carto::rc_ptr< VoxelSampler > voxelSampler=carto::rc_ptr< VoxelSampler >()) |
|
carto::rc_ptr< RoiIterator > | getRoiIterator (const Graph &data, carto::rc_ptr< VoxelSampler > voxelSampler=carto::rc_ptr< VoxelSampler >()) |
|
carto::rc_ptr< RoiIterator > | getRoiIterator (const std::string &fileName, const Motion &) |
|
carto::rc_ptr< RoiIterator > | getRoiIterator (const std::string &fileName, carto::rc_ptr< VoxelSampler > voxelSampler, const Motion &) |
|
carto::rc_ptr< RoiIterator > | getRoiIterator (const AimsData< T > &data, const Motion &motion) |
|
carto::rc_ptr< RoiIterator > | getRoiIterator (const Graph &data, const Motion &motion) |
|
carto::rc_ptr< RoiIterator > | getRoiIterator (const AimsData< T > &data, carto::rc_ptr< VoxelSampler > voxelSampler, const Motion &motion) |
|
carto::rc_ptr< RoiIterator > | getRoiIterator (const Graph &data, carto::rc_ptr< VoxelSampler > voxelSampler, const Motion &motion) |
|
aims::SparseMatrix | operator+ (const aims::SparseMatrix &thing) |
|
aims::SparseMatrix | operator- (const aims::SparseMatrix &thing) |
|
aims::SparseMatrix | operator+ (const aims::SparseMatrix &thing1, const aims::SparseMatrix &thing2) |
|
aims::SparseMatrix | operator- (const aims::SparseMatrix &thing1, const aims::SparseMatrix &thing2) |
|
aims::SparseMatrix | operator* (const aims::SparseMatrix &thing1, const aims::SparseMatrix &thing2) |
|
std::vector< double > | operator* (const aims::SparseMatrix &thing1, const std::vector< double > &thing2) |
|
aims::SparseMatrix | operator* (const aims::SparseMatrix &thing1, const double &thing2) |
|
aims::SparseMatrix | operator/ (const aims::SparseMatrix &thing1, const double &thing2) |
|
aims::SparseOrDenseMatrix | operator- (const aims::SparseOrDenseMatrix &thing) |
|
aims::SparseOrDenseMatrix | operator+ (const aims::SparseOrDenseMatrix &thing1, const aims::SparseOrDenseMatrix &thing2) |
|
aims::SparseOrDenseMatrix | operator- (const aims::SparseOrDenseMatrix &thing1, const aims::SparseOrDenseMatrix &thing2) |
|
aims::SparseOrDenseMatrix | operator* (const aims::SparseOrDenseMatrix &thing1, const double &thing2) |
|
aims::SparseOrDenseMatrix | operator/ (const aims::SparseOrDenseMatrix &thing1, const double &thing2) |
|
void | transformBoundingBox (const AffineTransformation3d &AffineTransformation3d, const Point3df &pmin1, const Point3df &pmax1, Point3df &pmin2, Point3df &pmax2) |
|
AffineTransformation3d | operator* (const AffineTransformation3d &affineTransformation3d1, const AffineTransformation3d &affineTransformation3d2) |
|
void | minmax (const ObjectType &, ValueType &min, ValueType &max) |
|
void | minmax (const AimsData< ValueType > &volume, ValueType &min, ValueType &max) |
|
void | minmax (const carto::Volume< ValueType > &volume, ValueType &min, ValueType &max) |
|
void | minmax (const carto::rc_ptr< carto::Volume< ValueType > > &volume, ValueType &min, ValueType &max) |
|
void | minmax (const carto::VolumeRef< ValueType > &volume, ValueType &min, ValueType &max) |
|
std::ostream & | operator<< (std::ostream &out, aims::ProgressInfo< T1, T2 > &progression) |
|
EcatReader< T > & | operator>> (EcatReader< T > &reader, AimsData< T > &thing) |
|
EcatSinoReader< T > & | operator>> (EcatSinoReader< T > &reader, std::vector< Sinogram< T > > &thing) |
|
EcatSinoWriter< T > & | operator<< (EcatSinoWriter< T > &writer, Sinogram< T > &thing) |
|
EcatSinoWriter< T > & | operator<< (EcatSinoWriter< T > &writer, const std::vector< Sinogram< T > > &thing) |
|
EcatWriter & | operator<< (EcatWriter &writer, const AimsData< short > &thing) |
|
EcatWriter & | operator<< (EcatWriter &writer, const AimsData< float > &thing) |
|
VidaReader< T > & | operator>> (VidaReader< T > &reader, AimsData< T > &thing) |
|
VidaWriter & | operator<< (VidaWriter &writer, const AimsData< short > &thing) |
|
VidaWriter & | operator<< (VidaWriter &writer, const AimsData< float > &thing) |
|
PlyReader< D, T > & | operator>> (PlyReader< D, T > &reader, AimsTimeSurface< D, T > &thing) |
|
PlyWriter< D, T > & | operator<< (PlyWriter< D, T > &writer, const AimsTimeSurface< D, T > &thing) |
|
AIMSDATA_API FdfReader< T > & | operator>> (FdfReader< T > &, AimsData< T > &) |
|
JpegReader< T > & | operator>> (JpegReader< T > &reader, AimsData< T > &thing) |
|
JpegWriter< T > & | operator<< (JpegWriter< T > &writer, const AimsData< T > &thing) |
|
TiffReader< T > & | operator>> (TiffReader< T > &reader, AimsData< T > &thing) |
|
TiffWriter< T > & | operator<< (TiffWriter< T > &writer, const AimsData< T > &thing) |
|
U | convertedNiftiValue (void *data, int index, int dtype) |
|
U | convertedNiftiArrayValue (void *data, int index, int dtype, size_t size) |
|
std::string | niftiDataType (int dt) |
|
int | niftiIntDataType (const std::string &typecode) |
|
std::string | giftiTextureDataType (int dtype, int &ndim, int *dims, int intent, int &ntime) |
|
AIMSDATA_API REAL | AimsLagrangeInterpolationOf (const AimsData< REAL > &xa, const AimsData< REAL > &ya, REAL x, REAL *dy) |
|
float | AimsLagrangeInterpolation (const AimsData< float > &xa, const AimsData< float > &ya, float x, float *dy) |
|
T | sqr (const T &x) |
|
T | cub (const T &x) |
|
float | sgn (const T &x) |
|
T | absdiff (const T &x, const T &y) |
|
AimsRGB | absdiff (const AimsRGB &x, const AimsRGB &y) |
|
AimsRGBA | absdiff (const AimsRGBA &x, const AimsRGBA &y) |
|
TimeTexture< float > | rescaleConstraints (TimeTexture< float > tex, std::map< int, std::map< int, std::string > > map_global) |
|
TimeTexture< float > | rescaleLatitude (TimeTexture< float > tex) |
|
TimeTexture< float > | rescaleLongitude (TimeTexture< float > tex) |
|
TimeTexture< float > | constraintCleaner (TimeTexture< float > &texture, std::vector< std::set< uint > > neigh, AimsSurfaceTriangle mesh, float contr, float curvature, float elasticity) |
|
std::map< int, std::map< int, std::string > > | createCorrespMap (std::string &adr_cor, std::string &adr_file, std::string &side) |
|
TimeTexture< float > | EconstraintCleaner (TimeTexture< float > &texture, std::vector< std::set< uint > > neigh, AimsSurfaceTriangle mesh, float valeur) |
|
void | recurs_proc (int index, TimeTexture< float > &tex, TimeTexture< float > &result, std::vector< std::set< uint > > &neigh, float &value) |
|
int | nb_vertex (TimeTexture< float >tex, float value, int size) |
|
TimeTexture< float > | origin_meridian (TimeTexture< float > &tex, int nord, int sud, std::vector< std::set< uint > > neigh, AimsSurfaceTriangle mesh, TimeTexture< float > &poles) |
|
void | meridianLink (TimeTexture< float > &origine, TimeTexture< float > &finish, int flag, int nord, int sud, std::vector< std::set< uint > > neigh, AimsSurfaceTriangle mesh, TimeTexture< float > &poles) |
|
std::vector< unsigned > | buildOriginVector (TimeTexture< float > &tex, int nord, int sud, std::vector< std::set< uint > > neigh) |
|
void | findNearNeigh (int origine, int destination, TimeTexture< float > &tex_origine, int flag, AimsSurfaceTriangle mesh, std::vector< std::set< uint > > neigh) |
|
void | findNearNeighPoles (int origine, int destination, TimeTexture< float > &tex_origine, int flag, AimsSurfaceTriangle mesh, std::vector< std::set< uint > > neigh, TimeTexture< float > &dist_p) |
|
TimeTexture< float > | originNeighbourgs (TimeTexture< float > originMeridian, int nord, int sud, AimsSurfaceTriangle mesh, std::vector< std::set< uint > > neigh, TimeTexture< float > &poles) |
|
TimeTexture< float > | defineSides (TimeTexture< float > &sides, TimeTexture< float > &constraints, AimsSurfaceTriangle mesh, std::vector< std::set< uint > > neigh) |
|
TimeTexture< float > | defineSidesPoles (TimeTexture< float > &sides, TimeTexture< float > &constraints, AimsSurfaceTriangle mesh, std::vector< std::set< uint > > neigh) |
|
std::pair< int, int > | find_poles (TimeTexture< float > &, AimsSurfaceTriangle) |
|
float | compute2D_distance (float lon1, float lon2, float lat1, float lat2) |
|
void | init_texture_single (TimeTexture< float > &) |
|
void | drawGyri (std::string &adLong, std::string &adLat, std::string &adOut, std::string &adr_cor, std::string &side) |
|
TimeTexture< float > | dilate_texture (TimeTexture< float > &texture, float val, std::vector< std::set< uint > > neigh, AimsSurfaceTriangle mesh) |
|