1.2.1
CCC
 
matrix.cpp File Reference
#include "geoslib_old_f.h"
#include "geoslib_enum.h"
#include "Enum/ECst.hpp"
#include "Basic/Utilities.hpp"
#include "Basic/VectorHelper.hpp"
#include "Basic/OptCst.hpp"
#include <math.h>
#include <cmath>

Functions

int matrix_eigen (const double *a_in, int neq, double *value, double *vector)
 
void matrix_product_safe (int n1, int n2, int n3, const double *v1, const double *v2, double *v3)
 
int matrix_prod_norme (int transpose, int n1, int n2, const double *v1, const double *a, double *w)
 
void matrix_transpose (int n1, int n2, VectorDouble &v1, VectorDouble &w1)
 
int matrix_invert (double *a, int neq, int rank)
 
double matrix_determinant (int neq, const VectorDouble &b)
 
int matrix_cholesky_decompose (const double *a, double *tl, int neq)
 
void matrix_cholesky_product (int mode, int neq, int nrhs, const double *tl, const double *a, double *x)
 
void matrix_cholesky_invert (int neq, const double *tl, double *xl)
 
void matrix_combine (int nval, double coeffa, double *a, double coeffb, double *b, double *c)
 
int matrix_eigen_tridiagonal (const double *vecdiag, const double *vecinf, const double *vecsup, int neq, double *eigvec, double *eigval)
 

Function Documentation

int matrix_cholesky_decompose ( const double *  a,
double *  tl,
int  neq 
)

Performs the Cholesky triangular decomposition of a definite positive symmetric matrix A = t(TL) * TL

Returns
Return code: >0 rank of zero pivot or 0 if no error
Parameters
[in]asymmetric matrix
[in]neqnumber of equations in the system
[out]tlLower triangular matrix defined by column
Remarks
the matrix a[] is destroyed during the calculations
void matrix_cholesky_invert ( int  neq,
const double *  tl,
double *  xl 
)

Invert the Cholesky matrix

Parameters
[in]neqnumber of equations in the system
[in]tllower triangular matrix defined by column
[out]xllower triangular inverted matrix defined by column
void matrix_cholesky_product ( int  mode,
int  neq,
int  nrhs,
const double *  tl,
const double *  a,
double *  x 
)

Performs the product between a triangular and a square matrix TL is the lower triangular matrix and X is a square matrix

Parameters
[in]modeType of calculations: 0 : X=TU%*A 1 : X=TL%*A 2 : X=A%*TU 3 : X=A%*TL 4 : X=t(A)%*TU 5 : X=t(A)%*TL
[in]neqnumber of equations in the system
[in]nrhsnumber of columns in x
[in]tlTriangular matrix defined by column (dimension: neq * neq)
[in]amatrix (dimension neq * nrhs)
[out]xresulting matrix (dimension neq * nrhs)
void matrix_combine ( int  nval,
double  coeffa,
double *  a,
double  coeffb,
double *  b,
double *  c 
)

Perform a linear combination of matrices or vectors [C] = 'coeffa' * [A] + 'coeffb' * [B]

Parameters
[in]nvalNumber of elements of the matrices or vectors
[in]coeffaCoefficient applied to the first matrix or vector
[in]aFirst matrix or vector (not used if NULL)
[in]coeffbCoefficient applied to the second matrix or vector
[in]bSecond matrix or vector (not used if NULL)
[out]cResulting matrix or vector
Remarks
No test is performed to check that the three matrices or vectors
have the same dimensions
Matrix c[] can coincide with matrices a[] or b[]
double matrix_determinant ( int  neq,
const VectorDouble b 
)

Calculate the determinant of the square matrix (full storage)

Returns
Value of the determinant
Parameters
[in]neqSize of the matrix
[in]bSquare matrix to be checked
int matrix_eigen ( const double *  a_in,
int  neq,
double *  value,
double *  vector 
)

Calculates the eigen values and eigen vectors of a symmetric square matrix A X = X l

Returns
Return code:
0 no error
1 convergence problem
Parameters
[in]a_insquare symmetric matrix (dimension = neq*neq)
[in]neqmatrix dimension
[out]valuematrix of the eigen values (dimension: neq)
[out]vectormatrix of the eigen vectors (dimension: neq*neq)
Remarks
a_in is protected
int matrix_eigen_tridiagonal ( const double *  vecdiag,
const double *  vecinf,
const double *  vecsup,
int  neq,
double *  eigvec,
double *  eigval 
)

Transform a tridiagonal non-symmetric matrix into a symmetric one

Returns
Error return code (see remarks)
Parameters
[in]vecdiagVector for the main diagonal
[in]vecinfVector for the subdiagonal (in the last neq-1 positions)
[in]vecsupVector for the superdiagonal (in the first neq positions)
[in]neqmatrix dimension
[out]eigvecsquare symmetric matrix (dimension: neq * neq)
[out]eigvalvector (dimensionL neq)
Remarks
Given the nonsymmetric tridiagonal matrix, we must have the products
of corresponding pairs of off-diagonal elements are all non-negative,
and zero only when both factors are zero
int matrix_invert ( double *  a,
int  neq,
int  rank 
)

Invert a symmetric square matrix Pivots are assumed to be located on the diagonal

Returns
Return code: 0 no error; k if the k-th pivot is zero
Parameters
[in,out]ainput matrix, destroyed in computation and replaced by resultant inverse
[in]neqnumber of equations in the matrix 'a'
[in]rankType of message when inversion problem is encountered >=0: message involves 'rank+1' -1: neutral message -2: no message
Remarks
It is unnecessary to edit a message if inversion problem occurs
int matrix_prod_norme ( int  transpose,
int  n1,
int  n2,
const double *  v1,
const double *  a,
double *  w 
)

Performs the product t(G) %*% A %*% G or G %*% A %*% t(G)

Returns
Error return code
Parameters
[in]transposetransposition mode -1 : transpose the first term +1 : transpose the last term
[in]n1matrix dimension
[in]n2matrix dimension
[in]v1rectangular matrix (n1,n2)
[in]asquare matrix (optional)
[out]wsquare matrix
Remarks
According to the value of 'transpose':
-1: the output array has dimension (n2,n2)
+1: the output array has dimension (n1,n1)
According to the value of 'transpose':
-1: the optional array A has dimension (n1,n1)
+1: the optional array A has dimension (n2,n2)
void matrix_product_safe ( int  n1,
int  n2,
int  n3,
const double *  v1,
const double *  v2,
double *  v3 
)

Performs the product of two matrices

Parameters
[in]n1matrix dimension
[in]n2matrix dimension
[in]n3matrix dimension
[in]v1rectangular matrix (n1,n2)
[in]v2rectangular matrix (n2,n3)
[out]v3rectangular matrix (n1,n3)
Remarks
The matrix v3[] may NOT coincide with one of the two initial ones
void matrix_transpose ( int  n1,
int  n2,
VectorDouble v1,
VectorDouble w1 
)

Transpose a (square or rectangular) matrix

Parameters
[in]n1matrix dimension
[in]n2matrix dimension
[in]v1rectangular matrix (n1,n2)
[out]w1rectangular matrix (n2,n1)
Remarks
The matrix w1[] may NOT coincide with v1[]