Basic Image AlgorithmS Library  2.8.0
 All Classes Namespaces Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
Public Types | Public Member Functions | Protected Member Functions | Protected Attributes | Related Functions | List of all members
TNT::Matrix< T > Class Template Reference

#include <Base/Math/tnt/cmat.h>

+ Inheritance diagram for TNT::Matrix< T >:

Public Types

typedef const T * const_iterator
 
typedef const T & const_reference
 
typedef T element_type
 
typedef T * iterator
 
typedef T * pointer
 
typedef T & reference
 
typedef Subscript size_type
 
typedef T value_type
 

Public Member Functions

Subscript dim (Subscript d) const
 
 initialize (M, N)
 
Subscript lbound () const
 
 Matrix ()
 
 Matrix (const Matrix< T > &A)
 
 Matrix (Subscript M, Subscript N, const T *v)
 
 Matrix (Subscript M, Subscript N, const std::string &s)
 replacement for above JW More...
 
Matrix< T > & newsize (Subscript M, Subscript N)
 
Subscript num_cols () const
 
Subscript num_rows () const
 
reference operator() (Subscript i)
 
const_reference operator() (Subscript i) const
 
reference operator() (Subscript i, Subscript j)
 
const_reference operator() (Subscript i, Subscript j) const
 
Matrix< T > & operator= (const Matrix< T > &A)
 
Matrix< T > & operator= (const T &scalar)
 
T * operator[] (Subscript i)
 
const T * operator[] (Subscript i) const
 
std::ostream & Print (std::ostream &s, const int width, const int precision, bool scientific=true) const
 
std::ostream & Print (std::ostream &s, const bool intCastOutput=false, const bool binaryOutput=false, const bool forceFullPrecision=false) const
 
std::ostream & PrintPretty (std::ostream &s, const std::string &name="", const int width=8, const bool alignLeft=true) const
 
std::istream & Read (std::istream &s, const bool intCastInput=false, const bool binaryInput=false)
 JW. More...
 
 set (value)
 
Subscript size () const
 
virtual ~Matrix ()
 

Protected Member Functions

void copy (const T *v)
 
void destroy ()
 
void initialize (Subscript M, Subscript N)
 
void set (const T &val)
 

Protected Attributes

Subscript m_
 
Subscript mn_
 
Subscript n_
 
T ** row_
 
T ** rowm1_
 
T * v_
 
T * vm1_
 

Related Functions

(Note that these are not member functions.)

template<class T >
Matrix< T > operator* (const Matrix< T > &A, const Matrix< T > &B)
 
template<class T >
Vector< T > operator* (const Matrix< T > &A, const Vector< T > &x)
 
template<class T >
Matrix< T > operator+ (const Matrix< T > &A, const Matrix< T > &B)
 
template<class T >
Matrix< T > operator- (const Matrix< T > &A, const Matrix< T > &B)
 
std::ostream & operator<< (std::ostream &s, const Matrix< char > &A)
 
std::ostream & operator<< (std::ostream &s, const Matrix< unsigned char > &A)
 
template<class T >
std::ostream & operator<< (std::ostream &s, const Matrix< T > &A)
 
std::istream & operator>> (std::istream &s, Matrix< unsigned char > &A)
 
std::istream & operator>> (std::istream &s, Matrix< char > &A)
 
template<class T >
std::istream & operator>> (std::istream &s, Matrix< T > &A)
 

Detailed Description

template<class T>
class TNT::Matrix< T >

Definition at line 66 of file cmat.h.

Member Typedef Documentation

template<class T>
typedef const T* TNT::Matrix< T >::const_iterator

Definition at line 78 of file cmat.h.

template<class T>
typedef const T& TNT::Matrix< T >::const_reference

Definition at line 79 of file cmat.h.

template<class T>
typedef T TNT::Matrix< T >::element_type

Definition at line 74 of file cmat.h.

template<class T>
typedef T* TNT::Matrix< T >::iterator

Definition at line 76 of file cmat.h.

template<class T>
typedef T* TNT::Matrix< T >::pointer

Definition at line 75 of file cmat.h.

template<class T>
typedef T& TNT::Matrix< T >::reference

Definition at line 77 of file cmat.h.

template<class T>
typedef Subscript TNT::Matrix< T >::size_type

Definition at line 72 of file cmat.h.

template<class T>
typedef T TNT::Matrix< T >::value_type

Definition at line 73 of file cmat.h.

Constructor & Destructor Documentation

template<class T>
TNT::Matrix< T >::Matrix ( )
inline

Definition at line 216 of file cmat.h.

template<class T>
TNT::Matrix< T >::Matrix ( const Matrix< T > &  A)
inline

Definition at line 219 of file cmat.h.

template<class T>
TNT::Matrix< T >::Matrix ( Subscript  M,
Subscript  N,
const T *  v 
)
inline

Definition at line 231 of file cmat.h.

template<class T>
TNT::Matrix< T >::Matrix ( Subscript  M,
Subscript  N,
const std::string &  s 
)
inline

replacement for above JW

Definition at line 248 of file cmat.h.

template<class T>
virtual TNT::Matrix< T >::~Matrix ( )
inlinevirtual

Member Function Documentation

template<class T>
void TNT::Matrix< T >::copy ( const T *  v)
inlineprotected
template<class T>
void TNT::Matrix< T >::destroy ( )
inlineprotected
template<class T>
Subscript TNT::Matrix< T >::dim ( Subscript  d) const
inline

Definition at line 310 of file cmat.h.

template<class T>
void TNT::Matrix< T >::initialize ( Subscript  M,
Subscript  N 
)
inlineprotected
template<class T>
TNT::Matrix< T >::initialize ( ,
 
)
template<class T>
Subscript TNT::Matrix< T >::lbound ( ) const
inline

Definition at line 81 of file cmat.h.

template<class T>
Matrix<T>& TNT::Matrix< T >::newsize ( Subscript  M,
Subscript  N 
)
inline
Examples:
EvaluateAlignment.cpp, ExampleAlignment.cpp, ExampleIEKF.cpp, ExampleLeastSquares.cpp, ExampleRegressionPlane.cpp, and ExampleUncertaintyTransform.cpp.

Definition at line 269 of file cmat.h.

Referenced by BIAS::Matrix< T >::Add(), BIAS::RegionMatcher::BilinearRegion(), BIAS::RegionMatcher::BilinearRegionColor3(), BIAS::ComputeCovariance(), BIAS::LDA::ComputeReductionMatrix(), BIAS::PCA::ComputeReductionMatrix(), BIAS::ContourBSplineShapeMatrix::ComputeRegularisationMatrix(), BIAS::ContourBSplineData::ComputeSplineMetricMatrix_(), BIAS::Matrix< T >::Conv(), BIAS::CamPoseCalib::CreateSecDMatrix_(), BIAS::Matrix< T >::Divide(), Eigenproblem_quadratic_matrix(), BIAS::CamPoseCalib::Estimate(), BIAS::TrackerBaseAffine< StorageType >::EvaluateResult_(), BIAS::TrackerBaseAffine2< StorageType >::EvaluateResult_(), BIAS::TrackerBaseInterface< StorageType >::EvaluateResult_(), BIAS::TrackerBaseInterface< StorageType >::Filter_ByMask(), BIAS::TrackerBaseInterface< StorageType >::Filter_BySeparableMask(), BIAS::TrackerBaseInterface< StorageType >::Filter_GradXSobel3x3(), BIAS::TrackerBaseInterface< StorageType >::Filter_GradYSobel3x3(), BIAS::TrackerBaseInterface< StorageType >::FilterLowpass_Binomial3x3(), BIAS::TrackerBaseInterface< StorageType >::FilterLowpass_ByMask(), BIAS::TrackerBaseInterface< StorageType >::FilterLowpass_BySeparableMask(), Fortran_Matrix_to_Matrix(), generalised_eigenvalue_matrix_solve(), BIAS::LDA::GenerateRandomTestData(), BIAS::SparseMatrix::GetAsDense(), BIAS::Random::GetMeanAndCovariance(), BIAS::PMatrixLinear::GetPEstSystemHom(), BIAS::PMatrixLinear::GetPEstSystemInHom(), BIAS::Matrix< T >::GetSystemMatrix(), BIAS::Kalman::Init(), BIAS::IteratedExtendedKalman::Init(), BIAS::SparseMatrix::Invert(), BIAS::SparseMatrix::InvertAndSolve(), BIAS::Matrix< T >::Kronecker(), Lapack_Cholesky_SymmetricPositiveDefinit(), BIAS::RegionMatcher::LinearRegionX(), BIAS::LevenbergMarquardtBase::LM_Compute(), BIAS::LevenbergMarquardtBase::LM_ComputeWithoutJacobian(), TNT::matmult(), BIAS::Matrix< T >::Mult(), BIAS::Matrix< T >::Multiply(), BIAS::Matrix< T >::MultiplyWithTransposeOf(), BIAS::MxArrToBIASMatrix(), BIAS::Matrix3x4< T >::newsize(), BIAS::Matrix4x4< T >::newsize(), BIAS::TextureTransformHomography::ParameterInversionJacobian(), BIAS::TextureTransformAffine::ParameterInversionJacobian(), BIAS::TextureTransformDisparity::ParameterInversionJacobian(), BIAS::TextureTransformDisplacement::ParameterInversionJacobian(), BIAS::TextureTransformRotation::ParameterInversionJacobian(), BIAS::TextureTransformEuclidian::ParameterInversionJacobian(), BIAS::TextureTransformAffine::ParameterJacobianBackward(), BIAS::TextureTransformHomography::ParameterJacobianBackward(), BIAS::TextureTransformDisparity::ParameterJacobianBackward(), BIAS::TextureTransformDisplacement::ParameterJacobianBackward(), BIAS::TextureTransformRotation::ParameterJacobianBackward(), BIAS::TextureTransformEuclidian::ParameterJacobianBackward(), BIAS::TextureTransformSimilar::ParameterJacobianBackward(), BIAS::TextureTransform::ParameterJacobianBackward(), BIAS::TextureTransformAffine::ParameterJacobianForward(), BIAS::TextureTransformHomography::ParameterJacobianForward(), BIAS::TextureTransformDisparity::ParameterJacobianForward(), BIAS::TextureTransformDisplacement::ParameterJacobianForward(), BIAS::TextureTransformRotation::ParameterJacobianForward(), BIAS::TextureTransformEuclidian::ParameterJacobianForward(), BIAS::TextureTransformSimilar::ParameterJacobianForward(), BIAS::TextureTransform::ParameterJacobianForward(), BIAS::IteratedExtendedKalman::Predict(), BIAS::Covariance3Dto2D::Project(), BIAS::Covariance3Dto2DHomg::Project(), BIAS::QRFrac(), BIAS::RegionMatcher::RegionMatcher(), BIAS::ContourBSplineShapeMatrix::SetShapeSpaceEuclidian(), BIAS::ContourBSplineShapeMatrix::SetShapeSpaceIdentity(), BIAS::ContourBSplineShapeMatrix::SetShapeSpaceMatrix(), BIAS::ContourBSplineShapeMatrix::SetShapeSpacePlanarAffin(), BIAS::ContourBSplineShapeMatrix::SetSubShapeSpaceZero(), BIAS::Matrix< T >::Sub(), BIAS::TrackerBaseAffine< StorageType >::TrackAffine_(), BIAS::MonteCarloTransform::Transform(), BIAS::UnscentedTransform::Transform(), BIAS::IteratedExtendedKalman::Update(), and BIAS::Tracker< StorageType, CalculationType >::Vector2FilterMask_().

template<class T>
Subscript TNT::Matrix< T >::num_cols ( ) const
inline
Examples:
ExampleGenerateGauss.cpp.

Definition at line 320 of file cmat.h.

Referenced by BIAS::Matrix< T >::Add(), BIAS::Matrix< T >::AddIP(), BIAS::ImageAlignment::Align(), BIAS::CamPoseCalib::ApplyCoVariances_(), BIAS::ImageAlignment::AutoAlign(), BIAS::TFTensorEstimation::Compute(), BIAS::SVD3x3::Compute(), BIAS::GaussHelmert::ComputeNormalSystem_(), BIAS::LDA::ComputeReductionMatrix(), BIAS::PCA::ComputeReductionMatrix(), BIAS::ContourBSplineShapeMatrix::ComputeRegularisationMatrix(), BIAS::PCA::ComputeScatter(), BIAS::UnscentedTransform::ComputeSigmaPoints_(), BIAS::LDA::ComputeWithinAndInterClassCovs(), BIAS::Matrix< T >::Conv(), BIAS::Matrix< T >::Divide(), BIAS::Matrix< T >::DivideElementwise(), Eigenproblem_quadratic_matrix(), Eigenvalue_solve(), BIAS::CamPoseCalib::Estimate(), Fortran_Matrix_to_Matrix(), General_singular_value_decomposition(), generalised_eigenvalue_matrix_solve(), BIAS::CamPoseCalib::GetCov(), BIAS::CamPoseCalib::GetCoVarMatrix(), BIAS::SVD::GetNullvector(), BIAS::Matrix< T >::Kronecker(), Lapack_Cholesky_SymmetricPositiveDefinit(), Lapack_LLS_QR_linear_solve(), Lapack_LU_linear_solve(), Lapack_WLLS_solve(), TNT::matmult(), BIAS::Matrix2x2< T >::Matrix2x2(), BIAS::Matrix3x3< T >::Matrix3x3(), BIAS::Matrix4x4< T >::Matrix4x4(), BIAS::Matrix< T >::Mult(), TNT::mult_element(), BIAS::Matrix< T >::Multiply(), BIAS::Matrix< T >::MultiplyWithTransposeOf(), TNT::Matrix< BIAS::BIAS::Vector< int > >::newsize(), BIAS::TrackerBaseInterface< StorageType >::NormalizeRegion_(), BIAS::Vector< T >::operator*(), BIAS::Vector3< T >::operator*(), BIAS::Vector4< T >::operator*(), TNT::Matrix< T >::operator+(), TNT::Matrix< T >::operator-(), BIAS::Matrix3x4< T >::operator=(), BIAS::Matrix4x4< T >::operator=(), BIAS::PMatrix::PMatrix(), BIAS::PMatrixBase::PMatrixBase(), BIAS::CovTransformPose::PoseEulerZYXToQuat(), BIAS::CovTransformPose::PoseQuatToEulerZYX(), BIAS::IteratedExtendedKalman::Predict(), BIAS::Covariance3Dto2DHomg::Project(), BIAS::RMatrix::RMatrix(), BIAS::RMatrixBase::RMatrixBase(), BIAS::Matrix< T >::Set(), BIAS::RParametrization::SetCovarianceMatrix(), BIAS::PoseParametrization::SetCovarianceMatrix(), BIAS::EParametrization::SetCovarianceMatrix(), BIAS::LocalAffineFrame::SetFromMatrix(), BIAS::IteratedExtendedKalman::SetProcessCov(), BIAS::ContourBSplineShapeMatrix::SetShapeSpaceMatrix(), BIAS::IteratedExtendedKalman::SetState(), BIAS::ContourBSplineShapeMatrix::SetSubShapeSpaceZero(), BIAS::GaussHelmert::Solve(), BIAS::LeastSquaresSVD::Solve(), BIAS::SVD::Solve(), BIAS::CamPoseCalib::SolveLM_(), BIAS::ImageAlignment::StrictPyramidAlign(), BIAS::Matrix< T >::Sub(), BIAS::Matrix< T >::SubIP(), BIAS::SymmetricMatrix3x3< T >::SymmetricMatrix3x3(), BIAS::TrackerBaseAffine< StorageType >::TrackAffine_(), BIAS::MonteCarloTransform::Transform(), BIAS::UnscentedTransform::Transform(), BIAS::CovTransformPose::TransformPoint3D(), BIAS::CovTransformPose::TransformPose(), TNT::transpose(), BIAS::Kalman::Update(), BIAS::IteratedExtendedKalman::Update(), and Upper_symmetric_eigenvalue_solve().

template<class T>
Subscript TNT::Matrix< T >::num_rows ( ) const
inline
Examples:
ExampleGenerateGauss.cpp.

Definition at line 319 of file cmat.h.

Referenced by BIAS::Matrix< T >::Add(), BIAS::Matrix< T >::AddIP(), BIAS::ImageAlignment::Align(), BIAS::ImageAlignment::AutoAlign(), BIAS::SVD3x3::Compute(), BIAS::ImageBlender::ComputeCylCamGeometry(), BIAS::ImageBlenderIncremental::ComputeCylCamGeometry_(), BIAS::LDA::ComputeReductionMatrix(), BIAS::PCA::ComputeReductionMatrix(), BIAS::ContourBSplineShapeMatrix::ComputeRegularisationMatrix(), BIAS::PCA::ComputeScatter(), BIAS::UnscentedTransform::ComputeSigmaPoints_(), BIAS::LDA::ComputeWithinAndInterClassCovs(), BIAS::Matrix< T >::Conv(), BIAS::Matrix< T >::Divide(), BIAS::Matrix< T >::DivideElementwise(), Eigenproblem_quadratic_matrix(), Eigenvalue_solve(), BIAS::CamPoseCalib::Estimate(), Fortran_Matrix_to_Matrix(), General_singular_value_decomposition(), generalised_eigenvalue_matrix_solve(), BIAS::CamPoseCalib::GetCov(), BIAS::CamPoseCalib::GetCoVarMatrix(), BIAS::SVD::GetLeftNullvector(), BIAS::Kalman::Init(), BIAS::IteratedExtendedKalman::Init(), BIAS::Matrix< T >::Kronecker(), Lapack_Cholesky_SymmetricPositiveDefinit(), Lapack_LLS_QR_linear_solve(), Lapack_LU_linear_solve(), Lapack_WLLS_solve(), TNT::matmult(), BIAS::Matrix2x2< T >::Matrix2x2(), BIAS::Matrix3x3< T >::Matrix3x3(), BIAS::Matrix4x4< T >::Matrix4x4(), BIAS::Matrix< T >::Mult(), TNT::mult_element(), BIAS::Matrix< T >::Multiply(), BIAS::Matrix< T >::MultiplyWithTransposeOf(), BIAS::Matrix< T >::MultLeft(), TNT::Matrix< BIAS::BIAS::Vector< int > >::newsize(), BIAS::TrackerBaseInterface< StorageType >::NormalizeRegion_(), BIAS::Vector< T >::operator*(), BIAS::Vector3< T >::operator*(), BIAS::Vector4< T >::operator*(), TNT::Matrix< T >::operator+(), TNT::Matrix< T >::operator-(), BIAS::Matrix3x4< T >::operator=(), BIAS::Matrix4x4< T >::operator=(), BIAS::PMatrix::PMatrix(), BIAS::PMatrixBase::PMatrixBase(), BIAS::CovTransformPose::PoseEulerZYXToQuat(), BIAS::CovTransformPose::PoseQuatToEulerZYX(), BIAS::IteratedExtendedKalman::Predict(), BIAS::RMatrix::RMatrix(), BIAS::RMatrixBase::RMatrixBase(), BIAS::Matrix< T >::Set(), BIAS::RParametrization::SetCovarianceMatrix(), BIAS::PoseParametrization::SetCovarianceMatrix(), BIAS::EParametrization::SetCovarianceMatrix(), BIAS::LocalAffineFrame::SetFromMatrix(), BIAS::IteratedExtendedKalman::SetProcessCov(), BIAS::ContourBSplineShapeMatrix::SetShapeSpaceMatrix(), BIAS::IteratedExtendedKalman::SetState(), BIAS::ContourBSplineShapeMatrix::SetSubShapeSpaceZero(), BIAS::GaussHelmert::Solve(), BIAS::LeastSquaresSVD::Solve(), BIAS::SVD::Solve(), BIAS::CamPoseCalib::SolveLM_(), SquaredMahalanobisDistance(), BIAS::ImageAlignment::StrictPyramidAlign(), BIAS::Matrix< T >::Sub(), BIAS::Matrix< T >::SubIP(), BIAS::SymmetricMatrix3x3< T >::SymmetricMatrix3x3(), BIAS::TrackerBaseAffine2< StorageType >::TrackAffine_(), BIAS::MonteCarloTransform::Transform(), BIAS::UnscentedTransform::Transform(), BIAS::CovTransformPose::TransformPoint3D(), BIAS::CovTransformPose::TransformPose(), TNT::transpose(), BIAS::Kalman::Update(), BIAS::IteratedExtendedKalman::Update(), Upper_symmetric_eigenvalue_solve(), and BIAS::LeastSquaresLapack::WeightedSolve().

template<class T>
reference TNT::Matrix< T >::operator() ( Subscript  i)
inline

Definition at line 343 of file cmat.h.

template<class T>
const_reference TNT::Matrix< T >::operator() ( Subscript  i) const
inline

Definition at line 352 of file cmat.h.

template<class T>
reference TNT::Matrix< T >::operator() ( Subscript  i,
Subscript  j 
)
inline

Definition at line 363 of file cmat.h.

template<class T>
const_reference TNT::Matrix< T >::operator() ( Subscript  i,
Subscript  j 
) const
inline

Definition at line 376 of file cmat.h.

template<class T>
Matrix<T>& TNT::Matrix< T >::operator= ( const Matrix< T > &  A)
inline

Definition at line 285 of file cmat.h.

Referenced by BIAS::Matrix< T >::Fill(), and BIAS::Matrix< T >::operator=().

template<class T>
Matrix<T>& TNT::Matrix< T >::operator= ( const T &  scalar)
inline

Definition at line 303 of file cmat.h.

template<class T>
T* TNT::Matrix< T >::operator[] ( Subscript  i)
inline

Definition at line 325 of file cmat.h.

template<class T>
const T* TNT::Matrix< T >::operator[] ( Subscript  i) const
inline

Definition at line 334 of file cmat.h.

template<class T>
std::ostream& TNT::Matrix< T >::Print ( std::ostream &  s,
const int  width,
const int  precision,
bool  scientific = true 
) const
inline
Author
Ingo Schiller
Examples:
ExampleSparseMatrix.cpp.
template<class T>
std::ostream& TNT::Matrix< T >::Print ( std::ostream &  s,
const bool  intCastOutput = false,
const bool  binaryOutput = false,
const bool  forceFullPrecision = false 
) const
inline
Author
Jan Woetzel
template<class T>
std::ostream& TNT::Matrix< T >::PrintPretty ( std::ostream &  s,
const std::string &  name = "",
const int  width = 8,
const bool  alignLeft = true 
) const
inline
Author
Sandro Esquivel
Examples:
ExampleSVD.cpp, and ExampleSVD3x3.cpp.
template<class T >
std::istream & TNT::Matrix< T >::Read ( std::istream &  s,
const bool  intCastInput = false,
const bool  binaryInput = false 
)
inline

JW.

Author
Jan Woetzel

Definition at line 605 of file cmat.h.

Referenced by TNT::Matrix< T >::operator>>().

template<class T>
void TNT::Matrix< T >::set ( const T &  val)
inlineprotected

Definition at line 152 of file cmat.h.

Referenced by TNT::Matrix< BIAS::BIAS::Vector< int > >::operator=().

template<class T>
TNT::Matrix< T >::set ( value  )
template<class T>
Subscript TNT::Matrix< T >::size ( ) const
inline

Friends And Related Function Documentation

template<class T >
Matrix< T > operator* ( const Matrix< T > &  A,
const Matrix< T > &  B 
)
related

Definition at line 842 of file cmat.h.

References TNT::matmult().

template<class T >
Vector< T > operator* ( const Matrix< T > &  A,
const Vector< T > &  x 
)
related

Definition at line 915 of file cmat.h.

References TNT::matmult().

template<class T >
Matrix< T > operator+ ( const Matrix< T > &  A,
const Matrix< T > &  B 
)
related

Definition at line 730 of file cmat.h.

References TNT::Matrix< T >::num_cols(), and TNT::Matrix< T >::num_rows().

template<class T >
Matrix< T > operator- ( const Matrix< T > &  A,
const Matrix< T > &  B 
)
related

Definition at line 752 of file cmat.h.

References TNT::Matrix< T >::num_cols(), and TNT::Matrix< T >::num_rows().

template<class T>
std::ostream & operator<< ( std::ostream &  s,
const Matrix< char > &  A 
)
related
Author
Jan Woetzel

Definition at line 663 of file cmat.h.

template<class T>
std::ostream & operator<< ( std::ostream &  s,
const Matrix< unsigned char > &  A 
)
related
Author
Jan Woetzel

Definition at line 670 of file cmat.h.

template<class T >
std::ostream & operator<< ( std::ostream &  s,
const Matrix< T > &  A 
)
related
Author
Jan Woetzel

Definition at line 695 of file cmat.h.

template<class T>
std::istream & operator>> ( std::istream &  s,
Matrix< unsigned char > &  A 
)
related
Author
Jan Woetzel

Definition at line 703 of file cmat.h.

References TNT::Matrix< T >::Read().

template<class T>
std::istream & operator>> ( std::istream &  s,
Matrix< char > &  A 
)
related
Author
Jan Woetzel

Definition at line 711 of file cmat.h.

References TNT::Matrix< T >::Read().

template<class T >
std::istream & operator>> ( std::istream &  s,
Matrix< T > &  A 
)
related
Author
Jan Woetzel

Definition at line 719 of file cmat.h.

References TNT::Matrix< T >::Read().

Member Data Documentation

template<class T>
Subscript TNT::Matrix< T >::m_
protected
template<class T>
Subscript TNT::Matrix< T >::mn_
protected
template<class T>
Subscript TNT::Matrix< T >::n_
protected
template<class T>
T** TNT::Matrix< T >::row_
protected
template<class T>
T** TNT::Matrix< T >::rowm1_
protected
template<class T>
T* TNT::Matrix< T >::v_
protected
template<class T>
T* TNT::Matrix< T >::vm1_
protected

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