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
BIAS::Matrix2x2< T > Class Template Reference

is a 'fixed size' quadratic matrix of dim. More...

#include <Base/Math/Matrix2x2.hh>

+ Inheritance diagram for BIAS::Matrix2x2< T >:
+ Collaboration diagram for BIAS::Matrix2x2< 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

void AbsIP ()
 absolute values of all elements of the matrix (in place) More...
 
Matrix< T > Adjoint () const
 computes the adjoint matrix More...
 
void clear ()
 stl conform interface More...
 
det () const
 calculate the determinante More...
 
Subscript dim (Subscript d) const
 
template<>
int EigenvalueDecomposition (double &value1, Vector2< double > &vec1, double &value2, Vector2< double > &vec2) const
 
int EigenvalueDecomposition (T &value1, Vector2< T > &vector1, T &value2, Vector2< T > &vector2) const
 Eigenvalue decomposition. More...
 
void GaussJordan ()
 use the Gauss Jordan Algrithm to transform the matrix to reduced row echelon form. More...
 
template<>
void GetAbsMaxMin (double &max, double &min) const
 
Matrix< T > GetMax (Matrix< T > &m)
 returns an matrix the same size as the matrix n and m with the largest elements taken from n or m More...
 
Matrix< T > GetMin (Matrix< T > &m)
 returns an matrix the same size as the matrix n and m with the smallest elements taken from n or m More...
 
 initialize (M, N)
 
template<>
int Invert (Matrix2x2< unsigned int > &result) const
 
int Invert (Matrix2x2< T > &result) const
 analyticaly inverts matrix More...
 
Matrix2x2< T > Invert () const
 
template<>
bool IsIdentity (double eps) const
 
bool IsIdentity (double eps=0.0) const
 Checks if the matrix a an identity. More...
 
template<>
bool IsZero (double eps) const
 
bool IsZero (double eps=0.0) const
 Checks if the matrix is a null matrix. More...
 
void Kronecker (Matrix< T > const B, Matrix< T > &dest) const
 Kronecker-product with matrix, result in dest. More...
 
Subscript lbound () const
 
 Matrix2x2 (const MatrixInitType &i)
 
 Matrix2x2 (const Matrix2x2< T > &A)
 
 Matrix2x2 (const TNT::Matrix< T > &A)
 cast constructor from TNT::Matrix More...
 
 Matrix2x2 ()
 
 Matrix2x2 (const std::string &s)
 
 Matrix2x2 (const T a0, const T a1, const T a2, const T a3)
 Set the matrix to | a0 a1 | | a2 a3 |. More...
 
void Mult (const Vector2< T > &argvec, Vector2< T > &destvec) const
 matrix - vector multiplicate this matrix with Vector2, storing the result in destvec calculates: destvec = (this Matrix) * argvec More...
 
void Mult (const Matrix2x2< T > &argmat, Matrix2x2< T > &destmat) const
 matrix-matrix multiplication with other Matrix2x2, storing the result in destmat calculates: destmat = (this mat) * argmat More...
 
void MultIP (const Matrix2x2< T > &argmat)
 Multiplication in place with argmat. More...
 
void MultLeft (const Vector2< T > &argvec, Vector2< T > &destvec) const
 matrix - vector multiplicate this matrix with Vector2, storing the result in destvec calculates: destvec^T = argvec^T * (this Matrix) More...
 
Vector2< T > MultLeft (const Vector2< T > &argvec) const
 transposed argvec multipied from left, wrapper function More...
 
Matrix2x2newsize (int rows, int cols)
 just neccessary to avoid resizing of this 'fixed size' matrix because it is derived from the resizable Matrix should be removed when Matrix2x2 becomes a base class. 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
 
Matrix2x2< T > & operator= (const Matrix2x2< T > &mat)
 assignment operator More...
 
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)
 
void SetIdentity ()
 set the elements of this matrix to the identity matrix More...
 
void SetZero ()
 set the elements of this matrix to zero More...
 
Subscript size () const
 
void SwapRows (const int i, const int r)
 swaps two rows More...
 
Matrix2x2< T > Transpose () const
 returns transposed matrix More...
 
void Transpose (const Matrix2x2< T > &arg)
 set this as transposed arg More...
 
void TransposeIP ()
 transpose matrix in place More...
 
void Vec (Vector< T > &dest) const
 vec-operator returns the elements of the matrix columwise as vector More...
 
virtual ~Matrix2x2 ()
 
Get Functions
GetMax () const
 Returns the maximum value of the matrix elements. More...
 
GetMin () const
 Returns the minimum value of the matrix elements. More...
 
T * GetData ()
 get the pointer to the data array of the matrix (for faster direct memeory access) More...
 
const T * GetData () const
 
const T ** GetDataArray () const
 returns zero based arry for data access More...
 
T ** GetDataArray ()
 
T ** GetDataArray1 () const
 returns 1 based array to data access More...
 
unsigned int GetRows () const
 
unsigned int GetCols () const
 
const T * GetDataLast () const
 Get a pointer to the last data element Do not use this on unitilized matrices with <= on pointers because on an unitilized matrix GetData() will be NULL and last Element < (typically FFFFF8) We don't want an if here for performance reasons of the innerst loop. More...
 
T * GetDataLast ()
 
Vector< T > GetRow (const int &row) const
 return a copy of row "row" of this matrix, zero based counting More...
 
Vector< T > GetCol (const int &col) const
 return a copy of column "col", zero based counting More...
 
void GetSubMatrix (const size_t startRow, const size_t startCol, const size_t numRows, const size_t numCols, Matrix< T > &submatrix) const
 return a submatrix from this. More...
 
void GetSubMatrix (const Vector< int > &rows, const Vector< int > &cols, Matrix< T > &submatrix) const
 return a submatrix from this. More...
 
Matrix< T > GetSubMatrix (const Vector< int > &rows, const Vector< int > &cols) const
 return a submatrix from this. More...
 
void SetSubMatrix (const size_t startRowInThis, const size_t startColInThis, const Matrix< T > &submatrix, const size_t startRowInSub, const size_t startColInSub, const size_t numRows, const size_t numCols)
 sets a submatrix in this. More...
 
void SetSubMatrix (const size_t startRowInThis, const size_t startColInThis, const Matrix3x3< T > &submatrix)
 sets a 3x3 submatrix in this. More...
 
void SetSubMatrix (const size_t startRowInThis, const size_t startColInThis, const Vector3< T > &subvector)
 sets a 3x1 submatrix in this. More...
 
void SetRow (const int row, const Vector< T > &data)
 set a row of matrix from vector More...
 
void SetCol (const int row, const Vector< T > &data)
 set a col of matrix from vector More...
 
void Set (const int row, const int col, const Matrix< T > &data)
 Copies the contents of data into this at the position indicated by row and col. More...
 
void Set (const int row, const int col, const Vector< T > &data)
 Copies the contents of data into this at the position indicated by row and col. More...
 
void SetTranspose (const int row, const int col, const Vector< T > &data)
 Copies the contents of data into this at the position indicated by row and col. More...
 
int GetNumElements () const
 Returns the total number of elements. More...
 
void GetMaxMin (T &max, T &min) const
 return biggest and smallest entry More...
 
void GetAbsMaxMin (T &max, T &min) const
 return biggest and smallest absolute values More...
 
GetMean () const
 Returns the mean value of the matrix elements. More...
 
NormL1 () const
 Return the L1 norm: |a| + |b| + |c| + ... More...
 
double NormL2 () const
 Return the L2 norm: a^2 + b^2 + c^2 + ... More...
 
double NormFrobenius () const
 Return Frobenius norm = sqrt(trace(A^t * A)). More...
 
Trace () const
 
DetSquare () const
 
Arithmetic
void AddIP (const T &scalar)
 in place addition function More...
 
void AddIP (const Matrix< T > &arg)
 Adds arg to this. More...
 
void SubIP (const Matrix< T > &arg)
 Subtracts arg from this
this -= arg. More...
 
void SubIP (const T &scalar)
 in place subtraction function More...
 
void Add (const T &scalar, Matrix< T > &dest) const
 addition function, storing data destination matrix More...
 
void Sub (const T &scalar, Matrix< T > &dest) const
 substraction function, storing data destination matrix More...
 
void MultiplyIP (const T &scalar)
 in place multiplication function More...
 
void Multiply (const T &scalar, Matrix< T > &dest) const
 multiplication function, storing data destination matrix More...
 
void Mult (const Matrix< T > &arg, Matrix< T > &result) const
 matrix multiplication, result is not allocated More...
 
void Mult (const Matrix< T > &arg)
 in Place matrix multiplication this is equal to M = M * arg, but faster More...
 
void Mult (const Vector< T > &arg, Vector< T > &result) const
 matrix vector multiplication, result is not allocated More...
 
void MultLeft (const Matrix< T > &arg)
 in Place matrix multiplication this is equal to M = arg*M, but faster More...
 
void MultLeft (const Vector< T > &arg, Vector< T > &result) const
 vector matrix multiplication result=arg*this. More...
 
void MultiplyWithTransposeOf (const Matrix< T > &arg, Matrix< T > &result) const
 matrix matrix multiplication for multiplication with the transpose of the given matrix, result=this*arg^T. More...
 
void DivideIP (const T &scalar)
 in place division function More...
 
void Divide (const T &scalar, Matrix< T > &dest) const
 division function, storing data destination matrix More...
 
void DivideElementwise (const Matrix< T > &arg)
 elementwise division function in place More...
 
void GetSystemMatrix (Matrix< T > &dest) const
 compute square system matrix dest = A^T * A More...
 
Set Functions
void MakeSymmetric ()
 componentwise: this = 0.5(this + this^T) yields symmetric matrix only allowed for square shaped matrices More...
 
void Fill (const T &scalar)
 Takes the elements of a Vector and put them as diagonal elements into a matrix. More...
 
Scaling and Normalization
void NormalizeColsToOne (const int norm_row_index)
 divides each column of the matrix through the element norm_row_index. More...
 
void NormalizeRowsToOne (const int norm_col_index)
 divides each row of the matrix through the element norm_col_index. More...
 
void NormalizeRows ()
 Normalizes each row to L2 norm one. More...
 
void NormalizeCols ()
 Normalizes each coloumn to L_2 norm one. More...
 
Normalize ()
 Normalizes the matrix by the entry with the biggest absolute value by dividing all elements with this one. More...
 
void ScaleRow (int NoRow, T scale)
 Scales row NoRow with scale. More...
 
void ScaleCol (int NoCol, T scale)
 Scales column NoCol with scale. More...
 
Input / Output
bool Load (const std::string &filename)
 method to load directly from a given filename. More...
 
bool Save (const std::string &filename) const
 method to save directly to a given filename. More...
 
int WriteMatlab (std::ostream &ostr, const std::string &name) const
 Write the matrix in Matlab format to the given stream. More...
 
bool BinRead (const char *filename) const
 This method reads a matrix from a given file in binary format. More...
 
bool BinWrite (const char *filename) const
 This method writes a matrix to a given file in binary format. More...
 

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 >
void Conv (const Matrix< T > &left, const Matrix< T > &right, Matrix< T > &res)
 zero padded convolution of two matrices More...
 
template<class T >
bool operator!= (const Matrix< T > &argl, const Matrix< T > &argr)
 
template<class T >
Matrix< T > operator* (const Matrix< T > &mat, const T &scalar)
 
template<class T >
Matrix< T > operator* (const T &scalar, const Matrix< T > &mat)
 
template<class T >
Matrix2x2< T > operator* (const Matrix2x2< T > &mat, const Matrix2x2< T > &argMat)
 
template<class T >
Matrix3x2< T > operator* (const Matrix3x2< T > &mat, const Matrix2x2< T > &argmat)
 
template<class T >
Matrix< T > operator* (const Matrix< T > &A, const Matrix< T > &B)
 
template<class T >
Matrix< T > operator* (const Matrix3x3< T > &argLeft, const Matrix< T > &argMat)
 
template<class T >
Vector< T > operator* (const Matrix< T > &A, const Vector< T > &x)
 
template<class T >
Matrix< T > & operator*= (Matrix< T > &mat, const T &scalar)
 
template<class T >
Matrix< T > operator+ (const Matrix< T > &mat, const T &scalar)
 
template<class T >
Matrix< T > operator+ (const T &scalar, const Matrix< T > &mat)
 
template<class T >
Matrix< T > operator+ (const Matrix< T > &A, const Matrix< T > &B)
 
template<class T >
Matrix< T > & operator+= (Matrix< T > &mat, const T &scalar)
 operators More...
 
template<class T >
Matrix< T > & operator+= (Matrix< T > &mat, const Matrix< T > &arg)
 
template<class T >
Matrix< T > operator- (const Matrix< T > &mat, const T &scalar)
 
template<class T >
Matrix< T > operator- (const T &scalar, const Matrix< T > &mat)
 
template<class T >
Matrix< T > operator- (const Matrix< T > &A, const Matrix< T > &B)
 
template<class T >
Matrix< T > & operator-= (Matrix< T > &mat, const Matrix< T > &arg)
 
template<class T >
Matrix< T > & operator-= (Matrix< T > &mat, const T &scalar)
 
template<class T >
Matrix< T > operator/ (const Matrix< T > &mat, const T &scalar)
 
template<class T >
Matrix< T > & operator/= (Matrix< T > &mat, const T &scalar)
 
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)
 
template<class T >
bool operator== (const Matrix< T > &argl, const Matrix< T > &argr)
 
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 = double>
class BIAS::Matrix2x2< T >

is a 'fixed size' quadratic matrix of dim.

2 x 2 which is templated over the elemnt-type.

Definition at line 48 of file Matrix2x2.hh.

Member Typedef Documentation

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

Definition at line 78 of file cmat.h.

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

Definition at line 79 of file cmat.h.

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

Definition at line 74 of file cmat.h.

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

Definition at line 76 of file cmat.h.

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

Definition at line 75 of file cmat.h.

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

Definition at line 77 of file cmat.h.

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

Definition at line 72 of file cmat.h.

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

Definition at line 73 of file cmat.h.

Constructor & Destructor Documentation

template<class T = double>
BIAS::Matrix2x2< T >::Matrix2x2 ( )
inline

Definition at line 51 of file Matrix2x2.hh.

template<class T = double>
BIAS::Matrix2x2< T >::Matrix2x2 ( const MatrixInitType i)
inlineexplicit

Definition at line 53 of file Matrix2x2.hh.

template<class T >
BIAS::Matrix2x2< T >::Matrix2x2 ( const std::string &  s)
explicit

Definition at line 70 of file Matrix2x2.cpp.

template<class T = double>
BIAS::Matrix2x2< T >::Matrix2x2 ( const Matrix2x2< T > &  A)
inline
Author
Jan Woetzel untested (04/17/2002)

Definition at line 72 of file Matrix2x2.hh.

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

cast constructor from TNT::Matrix

Definition at line 59 of file Matrix2x2.cpp.

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

template<class T>
BIAS::Matrix2x2< T >::Matrix2x2 ( const T  a0,
const T  a1,
const T  a2,
const T  a3 
)

Set the matrix to | a0 a1 | | a2 a3 |.

Definition at line 76 of file Matrix2x2.cpp.

References BIAS::Matrix< T >::GetData().

template<class T >
BIAS::Matrix2x2< T >::~Matrix2x2 ( )
virtual

Definition at line 86 of file Matrix2x2.cpp.

Member Function Documentation

template<class T >
void BIAS::Matrix< T >::AbsIP ( )
inherited

absolute values of all elements of the matrix (in place)

Author
bangerer 01/2009

Definition at line 199 of file Matrix.cpp.

template<class T>
void BIAS::Matrix< T >::Add ( const T &  scalar,
Matrix< T > &  dest 
) const
inlineinherited

addition function, storing data destination matrix

implementation

Author
Ingo Thomsen tested

Definition at line 753 of file Matrix.hh.

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

Referenced by BIAS::Matrix< T >::operator+().

template<class T>
void BIAS::Matrix< T >::AddIP ( const T &  scalar)
inlineinherited

in place addition function

Author
Ingo Thomsen tested

Definition at line 415 of file Matrix.hh.

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

template<class T>
void BIAS::Matrix< T >::AddIP ( const Matrix< T > &  arg)
inlineinherited

Adds arg to this.

Author
grest,2004

Definition at line 1033 of file Matrix.hh.

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

template<class T >
Matrix< T > BIAS::Matrix< T >::Adjoint ( ) const
inlineinherited

computes the adjoint matrix

Author
Christian Beder

Definition at line 833 of file Matrix.hh.

References BIAS::Matrix< T >::DetSquare().

template<class T >
bool BIAS::Matrix< T >::BinRead ( const char *  filename) const
inherited

This method reads a matrix from a given file in binary format.

The file is not human read-/editable but provides full precision. A dimension check is performed.

Returns
true on success
Author
mdunda 04 2004

Definition at line 565 of file Matrix.cpp.

template<class T >
bool BIAS::Matrix< T >::BinWrite ( const char *  filename) const
inherited

This method writes a matrix to a given file in binary format.

The file is not human read-/editable but provides full precision.

Returns
true on success
Author
mdunda 04 2004

Definition at line 600 of file Matrix.cpp.

template<class T = double>
void BIAS::Matrix2x2< T >::clear ( )
inlinevirtual

stl conform interface

Reimplemented from BIAS::Matrix< T >.

Definition at line 134 of file Matrix2x2.hh.

template<class T>
void TNT::Matrix< T >::copy ( const T *  v)
inlineprotectedinherited
template<class T>
void TNT::Matrix< T >::destroy ( )
inlineprotectedinherited
template<class T >
T BIAS::Matrix2x2< T >::det ( ) const
inline

calculate the determinante

Definition at line 266 of file Matrix2x2.hh.

Referenced by BIAS::Conic2D::GetLines(), and BIAS::ImageAlignment::SetAlignmentPixelsRectangular().

template<class T>
T BIAS::Matrix< T >::DetSquare ( ) const
inlineinherited
Author
koeser
Warning
very slow, generic implementation (order "n!"), better to use matrix decomposition (see BIAS/MathAlgo/Lapack.hh)

Definition at line 369 of file Matrix.hh.

Referenced by BIAS::Matrix< T >::Adjoint(), and BIAS::Matrix< EP_TYPE >::DetSquare().

template<class T>
Subscript TNT::Matrix< T >::dim ( Subscript  d) const
inlineinherited

Definition at line 310 of file cmat.h.

template<class T>
void BIAS::Matrix< T >::Divide ( const T &  scalar,
Matrix< T > &  dest 
) const
inlineinherited

division function, storing data destination matrix

Author
Ingo Thomsen tested

Definition at line 791 of file Matrix.hh.

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

Referenced by BIAS::Matrix< T >::operator/().

template<class T>
void BIAS::Matrix< T >::DivideElementwise ( const Matrix< T > &  arg)
inlineinherited

elementwise division function in place

Author
Ingo Schiller tested

Definition at line 809 of file Matrix.hh.

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

template<class T>
void BIAS::Matrix< T >::DivideIP ( const T &  scalar)
inlineinherited

in place division function

Author
Ingo Thomsen tested

Definition at line 486 of file Matrix.hh.

Referenced by BIAS::Matrix< T >::operator/=().

template<>
int BIAS::Matrix2x2< double >::EigenvalueDecomposition ( double &  value1,
Vector2< double > &  vec1,
double &  value2,
Vector2< double > &  vec2 
) const

Definition at line 140 of file Matrix2x2.cpp.

template<class T>
int BIAS::Matrix2x2< T >::EigenvalueDecomposition ( T &  value1,
Vector2< T > &  vector1,
T &  value2,
Vector2< T > &  vector2 
) const

Eigenvalue decomposition.

The eigenvalues and eigenvectors of the matrix are returned in value1/2 vector1/2.

Returns
number of linear independent eigenvectors = rank of matrix
Author
woelk 06/2005

Definition at line 131 of file Matrix2x2.cpp.

Referenced by BIAS::AffineMapping< InputStorageType, OutputStorageType >::ComputeScales(), BIAS::LocalAffineFrame::Draw(), BIAS::PyramidImage< StorageType >::GetAnisotropicImageValue(), BIAS::BackwardMapping< InputStorageType, OutputStorageType >::GetAnisotropicImageValue_(), BIAS::Conic2D::GetEllipseParameters(), and BIAS::Random::GetNormalDistributed().

template<class T>
void BIAS::Matrix< T >::Fill ( const T &  scalar)
inherited

Takes the elements of a Vector and put them as diagonal elements into a matrix.

The size of this Vector must be exactly min( matrix.width, matrix.height). Optionally all other elements may be set to zero

Author
Ingo Thomsen
Parameters
zero_othersMust be true, if all non-diagonal elements shall be set to zero

Definition at line 82 of file Matrix.cpp.

References TNT::Matrix< T >::operator=().

Referenced by BIAS::Interpolator::InitSpline3(), and BIAS::PMatrix::InvalidateDecomposition().

template<class T >
void BIAS::Matrix< T >::GaussJordan ( )
inherited

use the Gauss Jordan Algrithm to transform the matrix to reduced row echelon form.

Author
woelk 05/2008 www.vision-n.de

<< offset to right from diagonal, the working column is given by r+offs

<< r is the working row

this is guaranteed by the above

Definition at line 740 of file Matrix.cpp.

template<class T>
void BIAS::Matrix< T >::GetAbsMaxMin ( T &  max,
T &  min 
) const
inherited

return biggest and smallest absolute values

Definition at line 487 of file Matrix.cpp.

template<>
void BIAS::Matrix< double >::GetAbsMaxMin ( double &  max,
double &  min 
) const
inherited

Definition at line 494 of file Matrix.cpp.

template<class T >
Vector< T > BIAS::Matrix< T >::GetCol ( const int &  col) const
inherited
template<class T>
unsigned int BIAS::Matrix< T >::GetCols ( ) const
inlineinherited
template<class T>
T* BIAS::Matrix< T >::GetData ( )
inlineinherited

get the pointer to the data array of the matrix (for faster direct memeory access)

the order of the data is linewise, which means an elemnt sequence of e.g. [0] = M(0,0) [1] = M(0,1) [2] = M(0,2) [3] = M(1,0) // next line [4] = M(1,1) ...

Author
Jan Woetzel
Returns
a pointer to the data array (beginning with GetData[0]) alpha (02/27/2002) -added const (jw) 03/12/2002

Definition at line 185 of file Matrix.hh.

Referenced by BIAS::Matrix< T >::Add(), BIAS::Matrix< T >::AddIP(), BIAS::GLProjectionParametersBase::BeginDraw_(), BIAS::OpenSceneGraphHelper::BIAS2OSGMatrix(), BIAS::PMatrix::CheckDecomposition_(), BIAS::CheckJacobian(), BIAS::PMatrix::CheckSVD_(), BIAS::ComputeCovariance(), BIAS::ComputeJacobian(), BIAS::Matrix< T >::Divide(), BIAS::Matrix< T >::DivideElementwise(), Eigenproblem_quadratic_matrix(), BIAS::TrackerBaseInterface< StorageType >::EvaluateResult_(), Fortran_Matrix_to_Matrix(), BIAS::GenerateGauss::Gauss2D(), BIAS::TrackerBaseAffine< StorageType >::GetGradientWinAffine_(), BIAS::AffineMapping< InputStorageType, OutputStorageType >::GetJacobian_(), BIAS::Vector3< T >::GetSkewSymmetricMatrix(), BIAS::Matrix2x2< T >::Matrix2x2(), BIAS::Matrix3x3< T >::Matrix3x3(), BIAS::Matrix3x4< T >::Matrix3x4(), BIAS::Matrix4x4< T >::Matrix4x4(), BIAS::Matrix3x2< T >::Mult(), BIAS::Matrix2x3< T >::Mult(), BIAS::Matrix2x2< T >::Mult(), BIAS::Matrix3x3< T >::Mult(), BIAS::Matrix3x4< PMATRIX_TYPE >::Mult(), BIAS::Matrix4x4< PMATRIX_TYPE >::Mult(), BIAS::Matrix2x2< T >::MultIP(), BIAS::Matrix< T >::Multiply(), BIAS::TrackerBaseInterface< StorageType >::NormalizeRegion_(), BIAS::Matrix2x3< T >::operator*(), BIAS::Matrix3x2< T >::operator*(), BIAS::Matrix2x2< T >::operator*(), BIAS::Matrix3x3< T >::operator*(), BIAS::AffineTransf::operator=(), BIAS::Matrix3x2< T >::operator=(), BIAS::Matrix2x3< T >::operator=(), BIAS::Matrix2x2< T >::operator=(), BIAS::Matrix< T >::operator==(), BIAS::OpenSceneGraphHelper::OSG2BIASMatrix(), BIAS::TextureTransformHomography::ParameterInversionJacobian(), BIAS::TextureTransformAffine::ParameterInversionJacobian(), BIAS::TextureTransformHomography::ParameterJacobianBackward(), BIAS::TextureTransformHomography::ParameterJacobianForward(), BIAS::Camera< StorageType >::ParseMetaData(), BIAS::PMatrixBase::PMatrixBase(), BIAS::LocalAffineFrame::SetFromVector(), BIAS::GLProjectionParametersPerspective::SetGLMatrices(), BIAS::glfShaderProgram::SetUniform(), BIAS::Matrix< T >::Sub(), BIAS::Matrix< T >::SubIP(), BIAS::Matrix3x2< T >::Transpose(), BIAS::Matrix2x3< T >::Transpose(), BIAS::Matrix2x2< T >::Transpose(), BIAS::Vector4< T >::transposed(), BIAS::GLProjectionParametersPerspective::UpdateGLProjectionMatrix_(), BIAS::Tracker< StorageType, CalculationType >::Vector2FilterMask_(), BIAS::ProjectionParametersProjective::XMLIn(), and BIAS::ProjectionParametersProjective::XMLOut().

template<class T>
const T* BIAS::Matrix< T >::GetData ( ) const
inlineinherited

Definition at line 188 of file Matrix.hh.

template<class T>
const T** BIAS::Matrix< T >::GetDataArray ( ) const
inlineinherited

returns zero based arry for data access

Definition at line 192 of file Matrix.hh.

Referenced by BIAS::PMatrixLinear::ComputeCalibrated().

template<class T>
T** BIAS::Matrix< T >::GetDataArray ( )
inlineinherited

Definition at line 195 of file Matrix.hh.

template<class T>
T** BIAS::Matrix< T >::GetDataArray1 ( ) const
inlineinherited

returns 1 based array to data access

Definition at line 199 of file Matrix.hh.

template<class T>
const T* BIAS::Matrix< T >::GetDataLast ( ) const
inlineinherited

Get a pointer to the last data element Do not use this on unitilized matrices with <= on pointers because on an unitilized matrix GetData() will be NULL and last Element < (typically FFFFF8) We don't want an if here for performance reasons of the innerst loop.

Author
Ingo Thomsen, Jan Woetzel
Date
04/11/2002

Definition at line 213 of file Matrix.hh.

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

template<class T>
T* BIAS::Matrix< T >::GetDataLast ( )
inlineinherited

Definition at line 219 of file Matrix.hh.

template<class T>
Matrix< T > BIAS::Matrix< T >::GetMax ( Matrix< T > &  m)
inherited

returns an matrix the same size as the matrix n and m with the largest elements taken from n or m

Author
bangerer 01/2009

Definition at line 463 of file Matrix.cpp.

template<class T>
T BIAS::Matrix< T >::GetMax ( ) const
inherited

Returns the maximum value of the matrix elements.

Author
Ingo Thomsen
Date
04/11/2002 tested

Definition at line 449 of file Matrix.cpp.

template<class T>
void BIAS::Matrix< T >::GetMaxMin ( T &  max,
T &  min 
) const
inherited

return biggest and smallest entry

Definition at line 477 of file Matrix.cpp.

template<class T >
T BIAS::Matrix< T >::GetMean ( ) const
inherited

Returns the mean value of the matrix elements.

Author
Ingo Thomsen
Date
04/11/2002 tested

Definition at line 505 of file Matrix.cpp.

template<class T>
Matrix< T > BIAS::Matrix< T >::GetMin ( Matrix< T > &  m)
inherited

returns an matrix the same size as the matrix n and m with the smallest elements taken from n or m

Author
bangerer 01/2009

Definition at line 423 of file Matrix.cpp.

template<class T>
T BIAS::Matrix< T >::GetMin ( ) const
inherited

Returns the minimum value of the matrix elements.

Author
Ingo Thomsen
Date
04/11/2002 tested

Definition at line 409 of file Matrix.cpp.

template<class T>
int BIAS::Matrix< T >::GetNumElements ( ) const
inlineinherited

Returns the total number of elements.

Author
Ingo Thomsen
Date
04/11/2002 tested

Definition at line 321 of file Matrix.hh.

template<class T >
Vector< T > BIAS::Matrix< T >::GetRow ( const int &  row) const
inherited

return a copy of row "row" of this matrix, zero based counting

Author
Jan Woetzel

Definition at line 233 of file Matrix.cpp.

Referenced by BIAS::PMatrixLinear::Compute(), BIAS::PMatrixLinear::ComputeCalibrated(), BIAS::clfTrimmedICP::ComputeOptimalMotion_(), BIAS::LDA::GenerateRandomTestData(), and BIAS::Triangulation::TriangulateLinear().

template<class T>
unsigned int BIAS::Matrix< T >::GetRows ( ) const
inlineinherited
template<class T>
void BIAS::Matrix< T >::GetSubMatrix ( const size_t  startRow,
const size_t  startCol,
const size_t  numRows,
const size_t  numCols,
Matrix< T > &  submatrix 
) const
inherited

return a submatrix from this.

Start index is [startRow][startCol] end index is [startRow+numRows-1][startCol+numCols-1]. submatrix is resized to numRows/numCols if necessary.

Author
apetersen 12/2010

Definition at line 285 of file Matrix.cpp.

template<class T>
void BIAS::Matrix< T >::GetSubMatrix ( const Vector< int > &  rows,
const Vector< int > &  cols,
Matrix< T > &  submatrix 
) const
inherited

return a submatrix from this.

Similar to matlab notation (except indexing, starts with 0 of course!). Vectors rows = '1 3' and cols = '1 2' for matrix: / 1 2 3 \ | 4 5 6 | \ 7 8 9 / results in: / 1 2 \ \ 7 8 / Matrix has to be initialized!!!

Author
apetersen 7/2011

Definition at line 305 of file Matrix.cpp.

template<class T>
Matrix< T > BIAS::Matrix< T >::GetSubMatrix ( const Vector< int > &  rows,
const Vector< int > &  cols 
) const
inherited

return a submatrix from this.

Similar to matlab notation (except indexing, starts with 0 of course!), see GetSubMatrix(const Vector<int> &rows, const Vector<int> &cols, Matrix<T> &submatrix)

Author
apetersen 7/2011

Definition at line 317 of file Matrix.cpp.

References TNT::Vector< T >::size().

template<class T>
void BIAS::Matrix< T >::GetSystemMatrix ( Matrix< T > &  dest) const
inlineinherited

compute square system matrix dest = A^T * A

Parameters
destholds result of this->Transpose * this

If you want to solve A * x = b, where A has more rows than columns, a common technique is to solve x = (A^T * A)^-1 * A^T * b. This function provides a fast way to compute A^T*A from A.

Author
grest/koeser

Hessian is symmetric! so first diagonal then lower left

Definition at line 1075 of file Matrix.hh.

References TNT::Matrix< T >::newsize(), and BIAS::Matrix< T >::SetZero().

Referenced by BIAS::AffineMapping< InputStorageType, OutputStorageType >::ComputeScales(), BIAS::BackwardMapping< InputStorageType, OutputStorageType >::GetAnisotropicImageValue_(), BIAS::GetBaseLevel(), BIAS::LocalAffineFrame::GetLocalSimilarityFrame(), BIAS::CamPoseCalib::outputPose_(), BIAS::SVD::Solve(), and BIAS::CamPoseCalib::SolveLM_().

template<class T>
void TNT::Matrix< T >::initialize ( Subscript  M,
Subscript  N 
)
inlineprotectedinherited
template<class T>
TNT::Matrix< T >::initialize ( ,
 
)
inherited
template<>
int BIAS::Matrix2x2< unsigned int >::Invert ( Matrix2x2< unsigned int > &  result) const

Definition at line 107 of file Matrix2x2.cpp.

template<class T>
int BIAS::Matrix2x2< T >::Invert ( Matrix2x2< T > &  result) const
template<class T = double>
Matrix2x2<T> BIAS::Matrix2x2< T >::Invert ( ) const
inline

Definition at line 152 of file Matrix2x2.hh.

template<>
bool BIAS::Matrix< double >::IsIdentity ( double  eps) const
inherited

Definition at line 654 of file Matrix.cpp.

template<class T >
bool BIAS::Matrix< T >::IsIdentity ( double  eps = 0.0) const
inherited

Checks if the matrix a an identity.

I.e. all elements with index i==j are equal 1 and all others are zero.

Author
mdunda 12 2003
Returns
true if matrix is identity

Definition at line 669 of file Matrix.cpp.

Referenced by BIAS::TrifocalTensor::Compose().

template<>
bool BIAS::Matrix< double >::IsZero ( double  eps) const
inherited

Definition at line 626 of file Matrix.cpp.

template<class T >
bool BIAS::Matrix< T >::IsZero ( double  eps = 0.0) const
inherited

Checks if the matrix is a null matrix.

Author
mdunda 12 2003
Returns
true if all elements are zero

Definition at line 638 of file Matrix.cpp.

Referenced by BIAS::MonteCarloTransform::Transform().

template<class T>
void BIAS::Matrix< T >::Kronecker ( Matrix< T > const  B,
Matrix< T > &  dest 
) const
inherited

Kronecker-product with matrix, result in dest.

Kronecker-product with matrix B, result in dest.

Definition at line 702 of file Matrix.cpp.

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

Referenced by BIAS::TrackerBaseHomography< StorageType >::Track_().

template<class T>
Subscript TNT::Matrix< T >::lbound ( ) const
inlineinherited

Definition at line 81 of file cmat.h.

template<class T >
bool BIAS::Matrix< T >::Load ( const std::string &  filename)
inherited

method to load directly from a given filename.

internally using stream operator

Author
Jan Woetzel 05/2003
Returns
false in case of error, true in case of success

Definition at line 518 of file Matrix.cpp.

template<class T>
void BIAS::Matrix< T >::MakeSymmetric ( )
inlineinherited

componentwise: this = 0.5(this + this^T) yields symmetric matrix only allowed for square shaped matrices

Author
koeser 01/2007

Definition at line 522 of file Matrix.hh.

Referenced by BIAS::CamPoseCalib::GetCoVarMatrix(), BIAS::Covariance3Dto2DHomg::Project(), SquaredMahalanobisDistance(), and BIAS::CovTransformPose::TransformPoint3D().

template<class T>
void BIAS::Matrix2x2< T >::Mult ( const Vector2< T > &  argvec,
Vector2< T > &  destvec 
) const
inline

matrix - vector multiplicate this matrix with Vector2, storing the result in destvec calculates: destvec = (this Matrix) * argvec

Definition at line 228 of file Matrix2x2.hh.

Referenced by BIAS::ImageBlender::ComputeCylCamGeometry(), BIAS::ImageBlenderIncremental::ComputeCylCamGeometry_(), and BIAS::ContourDetectorBSpline< StorageType >::Rotate().

template<class T>
void BIAS::Matrix2x2< T >::Mult ( const Matrix2x2< T > &  argmat,
Matrix2x2< T > &  destmat 
) const
inline

matrix-matrix multiplication with other Matrix2x2, storing the result in destmat calculates: destmat = (this mat) * argmat

Definition at line 189 of file Matrix2x2.hh.

References BIAS::Matrix< T >::GetData().

template<class T>
void BIAS::Matrix< T >::Mult ( const Matrix< T > &  arg,
Matrix< T > &  result 
) const
inlineinherited
template<class T>
void BIAS::Matrix< T >::Mult ( const Matrix< T > &  arg)
inlineinherited

in Place matrix multiplication this is equal to M = M * arg, but faster

Author
Daniel Grest

Definition at line 939 of file Matrix.hh.

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

template<class T>
void BIAS::Matrix< T >::Mult ( const Vector< T > &  arg,
Vector< T > &  result 
) const
inlineinherited

matrix vector multiplication, result is not allocated

Author
Felix Woelk

Definition at line 955 of file Matrix.hh.

References BIAS::Vector< T >::Fill(), TNT::Vector< T >::newsize(), and TNT::Vector< T >::size().

template<class T>
void BIAS::Matrix2x2< T >::MultIP ( const Matrix2x2< T > &  argmat)
inline

Multiplication in place with argmat.

Definition at line 209 of file Matrix2x2.hh.

References BIAS::Matrix< T >::GetData().

template<class T>
void BIAS::Matrix< T >::Multiply ( const T &  scalar,
Matrix< T > &  dest 
) const
inlineinherited

multiplication function, storing data destination matrix

Author
Ingo Thomsen tested

Definition at line 779 of file Matrix.hh.

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

Referenced by BIAS::ContourDetectorBSpline< StorageType >::Fit_(), and BIAS::Matrix< T >::operator*().

template<class T>
void BIAS::Matrix< T >::MultiplyIP ( const T &  scalar)
inlineinherited
template<class T>
void BIAS::Matrix< T >::MultiplyWithTransposeOf ( const Matrix< T > &  arg,
Matrix< T > &  result 
) const
inlineinherited

matrix matrix multiplication for multiplication with the transpose of the given matrix, result=this*arg^T.

Author
Arne Petersen

Definition at line 1006 of file Matrix.hh.

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

template<class T>
void BIAS::Matrix2x2< T >::MultLeft ( const Vector2< T > &  argvec,
Vector2< T > &  destvec 
) const
inline

matrix - vector multiplicate this matrix with Vector2, storing the result in destvec calculates: destvec^T = argvec^T * (this Matrix)

Definition at line 239 of file Matrix2x2.hh.

template<class T = double>
Vector2<T> BIAS::Matrix2x2< T >::MultLeft ( const Vector2< T > &  argvec) const
inline

transposed argvec multipied from left, wrapper function

Definition at line 100 of file Matrix2x2.hh.

template<class T>
void BIAS::Matrix< T >::MultLeft ( const Matrix< T > &  arg)
inlineinherited
template<class T>
void BIAS::Matrix< T >::MultLeft ( const Vector< T > &  arg,
Vector< T > &  result 
) const
inlineinherited

vector matrix multiplication result=arg*this.

Author
Marcel Lilienthal

Definition at line 978 of file Matrix.hh.

References TNT::Vector< T >::newsize(), BIAS::Vector< T >::SetZero(), and TNT::Vector< T >::size().

template<class T >
Matrix2x2< T > & BIAS::Matrix2x2< T >::newsize ( int  rows,
int  cols 
)

just neccessary to avoid resizing of this 'fixed size' matrix because it is derived from the resizable Matrix should be removed when Matrix2x2 becomes a base class.

(04/17/2002) Felix Woelk

Definition at line 98 of file Matrix2x2.cpp.

template<class T>
Matrix<T>& TNT::Matrix< T >::newsize ( Subscript  M,
Subscript  N 
)
inlineinherited
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::TextureTransformHomography::ParameterJacobianBackward(), BIAS::TextureTransformAffine::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::TextureTransformSimilar::ParameterJacobianForward(), BIAS::TextureTransformEuclidian::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 >
T BIAS::Matrix< T >::Normalize ( )
inherited

Normalizes the matrix by the entry with the biggest absolute value by dividing all elements with this one.

Returns
value of the element the matrix is normalized with
Author
mdunda 09 2003

Definition at line 437 of file Matrix.cpp.

template<class T >
void BIAS::Matrix< T >::NormalizeCols ( )
inherited

Normalizes each coloumn to L_2 norm one.

Attention each column is normaized by its own scale!

Definition at line 189 of file Matrix.cpp.

template<class T >
void BIAS::Matrix< T >::NormalizeColsToOne ( const int  norm_row_index)
inherited

divides each column of the matrix through the element norm_row_index.

index runs [0..num_rows-1] for example: 2 3 4 5 normalized with row '1' will be 2/4 3/5 1 1

Definition at line 89 of file Matrix.cpp.

template<class T >
void BIAS::Matrix< T >::NormalizeRows ( )
inherited

Normalizes each row to L2 norm one.

Attention each row is normaized by its own scale!

Definition at line 178 of file Matrix.cpp.

Referenced by BIAS::PMatrixLinear::Compute(), BIAS::PCA::ComputeReductionMatrix(), and BIAS::Triangulation::TriangulateLinear().

template<class T >
void BIAS::Matrix< T >::NormalizeRowsToOne ( const int  norm_col_index)
inherited

divides each row of the matrix through the element norm_col_index.

index runs [0..num_cols-1] for example: 2 3 4 5 normalized with row '1' will be 2/3 1 4/5 1

Definition at line 135 of file Matrix.cpp.

template<class T >
double BIAS::Matrix< T >::NormFrobenius ( ) const
inlineinherited

Return Frobenius norm = sqrt(trace(A^t * A)).

this method is deprecated because it is equivalent to NormL2

This function is deprecated, because it is equivalent to NormL2.

Author
koeser 02/2004

Definition at line 897 of file Matrix.hh.

Referenced by BIAS::LDA::ComputeWithinAndInterClassCovs(), BIAS::TriangleMesh::GenerateTexturedQuad(), BIAS::EMatrix::InitFromF(), SquaredMahalanobisDistance(), BIAS::TrackerBaseInterface< StorageType >::Track(), BIAS::TrackerBaseAffine< StorageType >::Track_(), and BIAS::TrackerBaseAffine2< StorageType >::Track_().

template<class T >
T BIAS::Matrix< T >::NormL1 ( ) const
inlineinherited

Return the L1 norm: |a| + |b| + |c| + ...

Author
Ingo Thomsen
Date
04/11/2002 untested

Definition at line 867 of file Matrix.hh.

template<class T >
double BIAS::Matrix< T >::NormL2 ( ) const
inlineinherited

Return the L2 norm: a^2 + b^2 + c^2 + ...

Author
woelk 07/2004

Definition at line 878 of file Matrix.hh.

Referenced by BIAS::ImageAlignment::Align(), BIAS::LDA::GenerateRandomTestData(), and BIAS::Camera< StorageType >::ParseMetaData().

template<class T>
Subscript TNT::Matrix< T >::num_cols ( ) const
inlineinherited
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
inlineinherited
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)
inlineinherited

Definition at line 343 of file cmat.h.

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

Definition at line 352 of file cmat.h.

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

Definition at line 363 of file cmat.h.

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

Definition at line 376 of file cmat.h.

template<class T>
Matrix2x2< T > & BIAS::Matrix2x2< T >::operator= ( const Matrix2x2< T > &  mat)

assignment operator

Definition at line 89 of file Matrix2x2.cpp.

References BIAS::Matrix< T >::GetData().

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

Definition at line 325 of file cmat.h.

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

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
inlineinherited
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
inlineinherited
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
inlineinherited
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 
)
inlineinherited

JW.

Author
Jan Woetzel

Definition at line 605 of file cmat.h.

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

template<class T >
bool BIAS::Matrix< T >::Save ( const std::string &  filename) const
inherited

method to save directly to a given filename.

internally using stream operator

Author
Jan Woetzel 05/2003
Returns
false in case of error, true in case of success

Definition at line 532 of file Matrix.cpp.

template<class T>
void BIAS::Matrix< T >::ScaleCol ( int  NoCol,
scale 
)
inherited

Scales column NoCol with scale.

Definition at line 224 of file Matrix.cpp.

template<class T>
void BIAS::Matrix< T >::ScaleRow ( int  NoRow,
scale 
)
inherited

Scales row NoRow with scale.

Definition at line 215 of file Matrix.cpp.

Referenced by BIAS::LeastSquaresLapack::WeightedSolve(), and BIAS::LeastSquaresSVD::WeightedSolve().

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

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  )
inherited
template<class T>
void BIAS::Matrix< T >::Set ( const int  row,
const int  col,
const Matrix< T > &  data 
)
inherited

Copies the contents of data into this at the position indicated by row and col.

The size of *this must be big enought to carry data

Author
woelk 05/2008 (c) www.vision-n.de

Definition at line 816 of file Matrix.cpp.

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

Referenced by BIAS::CoordinateTransform3D::SetFromMatrix3x4().

template<class T>
void BIAS::Matrix< T >::Set ( const int  row,
const int  col,
const Vector< T > &  data 
)
inherited

Copies the contents of data into this at the position indicated by row and col.

The size of *this must be big enought to carry data. Data i interpreted as column vector

Author
woelk 05/2008 (c) www.vision-n.de

Definition at line 834 of file Matrix.cpp.

References TNT::Vector< T >::size().

template<class T>
void BIAS::Matrix< T >::SetCol ( const int  row,
const Vector< T > &  data 
)
inherited

set a col of matrix from vector

Author
woelk 08/2004

Definition at line 275 of file Matrix.cpp.

References TNT::Vector< T >::size().

Referenced by BIAS::FMatrixEstimation::GoldStandard().

template<class T >
void BIAS::Matrix2x2< T >::SetIdentity ( )
inline
template<class T>
void BIAS::Matrix< T >::SetRow ( const int  row,
const Vector< T > &  data 
)
inherited

set a row of matrix from vector

Author
woelk 08/2004

Definition at line 265 of file Matrix.cpp.

References TNT::Vector< T >::size().

Referenced by BIAS::Triangulation::GetCovarianceProjective().

template<class T>
void BIAS::Matrix< T >::SetSubMatrix ( const size_t  startRowInThis,
const size_t  startColInThis,
const Matrix< T > &  submatrix,
const size_t  startRowInSub,
const size_t  startColInSub,
const size_t  numRows,
const size_t  numCols 
)
inherited

sets a submatrix in this.

Start index in this is [startRowInThis][startColInThis] end index is [startRowInThis+numRows-1][startColInThis+numCols-1]. Entries copyed from submatrix beginning at [startRowInSub][startColInSub] and stop at [startRowInSub+numRows-1][startColInSub+numCols-1]

Author
apetersen 12/2010

Definition at line 331 of file Matrix.cpp.

template<class T>
void BIAS::Matrix< T >::SetSubMatrix ( const size_t  startRowInThis,
const size_t  startColInThis,
const Matrix3x3< T > &  submatrix 
)
inherited

sets a 3x3 submatrix in this.

Start index in this is [startRowInThis][startColInThis] end index is [startRowInThis+2][startColInThis+2].

Author
apetersen 12/2010

Definition at line 353 of file Matrix.cpp.

template<class T>
void BIAS::Matrix< T >::SetSubMatrix ( const size_t  startRowInThis,
const size_t  startColInThis,
const Vector3< T > &  subvector 
)
inherited

sets a 3x1 submatrix in this.

Start index in this is [startRowInThis][startColInThis] end index is [startRowInThis+2][startColInThis].

Author
apetersen 12/2010

Definition at line 369 of file Matrix.cpp.

template<class T>
void BIAS::Matrix< T >::SetTranspose ( const int  row,
const int  col,
const Vector< T > &  data 
)
inherited

Copies the contents of data into this at the position indicated by row and col.

The size of *this must be big enought to carry data. Data is interpreted as row vector.

Author
woelk 05/2008 (c) www.vision-n.de

Definition at line 850 of file Matrix.cpp.

References TNT::Vector< T >::size().

template<class T >
void BIAS::Matrix2x2< T >::SetZero ( )
inline
template<class T>
Subscript TNT::Matrix< T >::size ( ) const
inlineinherited
template<class T>
void BIAS::Matrix< T >::Sub ( const T &  scalar,
Matrix< T > &  dest 
) const
inlineinherited

substraction function, storing data destination matrix

Author
Ingo Thomsen tested

Definition at line 766 of file Matrix.hh.

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

Referenced by BIAS::Matrix< T >::operator-().

template<class T>
void BIAS::Matrix< T >::SubIP ( const Matrix< T > &  arg)
inlineinherited

Subtracts arg from this
this -= arg.

Author
grest, 2004

Definition at line 1054 of file Matrix.hh.

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

Referenced by BIAS::Matrix< T >::operator-=().

template<class T>
void BIAS::Matrix< T >::SubIP ( const T &  scalar)
inlineinherited

in place subtraction function

Author
Ingo Thomsen tested

Definition at line 437 of file Matrix.hh.

template<class T >
void BIAS::Matrix< T >::SwapRows ( const int  i,
const int  r 
)
inherited

swaps two rows

Author
woelk 05/2008 www.vision-n.de

Definition at line 725 of file Matrix.cpp.

template<class T >
T BIAS::Matrix< T >::Trace ( ) const
inlineinherited
template<class T >
Matrix2x2< T > BIAS::Matrix2x2< T >::Transpose ( ) const
inline

returns transposed matrix

Definition at line 173 of file Matrix2x2.hh.

References BIAS::Matrix2x2< T >::Transpose().

Referenced by BIAS::Matrix2x2< T >::Transpose().

template<class T>
void BIAS::Matrix2x2< T >::Transpose ( const Matrix2x2< T > &  arg)
inline

set this as transposed arg

Definition at line 164 of file Matrix2x2.hh.

References BIAS::Matrix< T >::GetData().

template<class T >
void BIAS::Matrix2x2< T >::TransposeIP ( )
inline

transpose matrix in place

Definition at line 181 of file Matrix2x2.hh.

template<class T>
void BIAS::Matrix< T >::Vec ( Vector< T > &  dest) const
inherited

vec-operator returns the elements of the matrix columwise as vector

vec-operator returns the elements of the matrix columnwise as vector

Definition at line 689 of file Matrix.cpp.

References TNT::Vector< T >::newsize().

template<class T >
int BIAS::Matrix< T >::WriteMatlab ( std::ostream &  ostr,
const std::string &  name 
) const
inherited

Write the matrix in Matlab format to the given stream.

Parameters
nameIs the name of the Matlab variable
Author
streckel 08/2006
Returns
negativev if error

Definition at line 547 of file Matrix.cpp.

Friends And Related Function Documentation

template<class T >
void Conv ( const Matrix< T > &  left,
const Matrix< T > &  right,
Matrix< T > &  res 
)
related

zero padded convolution of two matrices

Author
woelk 01/2008 (c) www.vision-n.de

Definition at line 755 of file Operators.hh.

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

template<class T >
bool operator!= ( const Matrix< T > &  argl,
const Matrix< T > &  argr 
)
related

operator for not equal

Author
Ingo Thomsen (07/02/2002)

Definition at line 745 of file Matrix.hh.

template<class T >
Matrix< T > operator* ( const Matrix< T > &  mat,
const T &  scalar 
)
related

multiplication operator, returning new matrix

Author
Ingo Thomsen

Definition at line 604 of file Operators.hh.

References BIAS::Matrix< T >::Multiply().

template<class T >
Matrix< T > operator* ( const T &  scalar,
const Matrix< T > &  mat 
)
related

Definition at line 609 of file Operators.hh.

References BIAS::Matrix< T >::Multiply().

template<class T >
Matrix2x2< T > operator* ( const Matrix2x2< T > &  mat,
const Matrix2x2< T > &  argMat 
)
related

untested

Definition at line 788 of file Operators.hh.

References BIAS::Matrix< T >::GetData().

template<class T >
Matrix3x2< T > operator* ( const Matrix3x2< T > &  mat,
const Matrix2x2< T > &  argmat 
)
related

untested

Definition at line 832 of file Operators.hh.

References BIAS::Matrix< T >::GetData().

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 >
Matrix< T > operator* ( const Matrix3x3< T > &  argLeft,
const Matrix< T > &  argMat 
)
related

matrix-matrix multiplication using 'Mult'

Author
Jan Woetzel, tested (04/17/2002)

Definition at line 878 of file Operators.hh.

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*= ( Matrix< T > &  mat,
const T &  scalar 
)
related

multiplication operator

Author
Ingo Thomsen

Definition at line 719 of file Matrix.hh.

References BIAS::Matrix< T >::MultiplyIP().

template<class T >
Matrix< T > operator+ ( const Matrix< T > &  mat,
const T &  scalar 
)
related

addition operator, returning new matrix

Author
Ingo Thomsen, woelk

Definition at line 534 of file Operators.hh.

References BIAS::Matrix< T >::Add().

template<class T >
Matrix< T > operator+ ( const T &  scalar,
const Matrix< T > &  mat 
)
related

Definition at line 539 of file Operators.hh.

References BIAS::Matrix< T >::Add().

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+= ( Matrix< T > &  mat,
const T &  scalar 
)
related

operators

addition operator

Author
Ingo Thomsen

Definition at line 691 of file Matrix.hh.

References BIAS::Matrix< T >::AddIP().

template<class T >
Matrix< T > & operator+= ( Matrix< T > &  mat,
const Matrix< T > &  arg 
)
related

addition in place operator

Author
grest

Definition at line 698 of file Matrix.hh.

References BIAS::Matrix< T >::AddIP().

template<class T >
Matrix< T > operator- ( const Matrix< T > &  mat,
const T &  scalar 
)
related

substraction operator, returning new matrix

Author
Ingo Thomsen

Definition at line 546 of file Operators.hh.

References BIAS::Matrix< T >::Sub().

template<class T >
Matrix< T > operator- ( const T &  scalar,
const Matrix< T > &  mat 
)
related

Definition at line 551 of file Operators.hh.

References BIAS::Matrix< T >::Sub().

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 >
Matrix< T > & operator-= ( Matrix< T > &  mat,
const Matrix< T > &  arg 
)
related

subtracts arg from mat, mat = mat - arg

Author
grest

Definition at line 705 of file Matrix.hh.

References BIAS::Matrix< T >::SubIP().

template<class T >
Matrix< T > & operator-= ( Matrix< T > &  mat,
const T &  scalar 
)
related

substraction operator

Author
Ingo Thomsen

Definition at line 712 of file Matrix.hh.

References BIAS::Matrix< T >::AddIP().

template<class T >
Matrix< T > operator/ ( const Matrix< T > &  mat,
const T &  scalar 
)
related

division operator, returning new matrix

Author
Ingo Thomsen

Definition at line 616 of file Operators.hh.

References BIAS::Matrix< T >::Divide().

template<class T >
Matrix< T > & operator/= ( Matrix< T > &  mat,
const T &  scalar 
)
related

division operator

Author
Ingo Thomsen

Definition at line 623 of file Operators.hh.

References BIAS::Matrix< T >::DivideIP().

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 >
bool operator== ( const Matrix< T > &  argl,
const Matrix< T > &  argr 
)
related

operator for equal

Author
Ingo Thomsen (07/02/2002) tested

Definition at line 730 of file Matrix.hh.

References BIAS::Matrix< T >::GetData(), BIAS::Matrix< T >::GetDataLast(), and TNT::Matrix< T >::size().

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_
protectedinherited
template<class T>
Subscript TNT::Matrix< T >::mn_
protectedinherited
template<class T>
Subscript TNT::Matrix< T >::n_
protectedinherited
template<class T>
T** TNT::Matrix< T >::row_
protectedinherited
template<class T>
T** TNT::Matrix< T >::rowm1_
protectedinherited
template<class T>
T* TNT::Matrix< T >::v_
protectedinherited
template<class T>
T* TNT::Matrix< T >::vm1_
protectedinherited

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