42#ifndef _TEUCHOS_SERIALDENSEHELPERS_HPP_
43#define _TEUCHOS_SERIALDENSEHELPERS_HPP_
75template<
typename OrdinalType,
typename ScalarType>
81 OrdinalType A_nrowcols =
A.numRows();
86 bool isBUpper =
B.upper();
90 "Teuchos::symMatTripleProduct<>() : "
91 "Num Rows/Cols B (" <<
B.numRows() <<
") inconsistent with W ("<< B_nrowcols <<
")");
93 "Teuchos::symMatTripleProduct<>() : "
94 "Num Rows/Cols A (" << A_nrowcols <<
") inconsistent with W ("<< W_nrows <<
")");
121 for (OrdinalType j=0; j<B_nrowcols; ++j)
122 blas.
GEMV( transw, W_nrows, j+1, one, W.
values(), W.
stride(), AW[j], 1, zero, &
B(0,j), 1 );
125 for (OrdinalType j=0; j<B_nrowcols; ++j)
126 blas.
GEMV( transw, W_nrows, B_nrowcols-j, one, W[j], W.
stride(), AW[j], 1, zero, &
B(j,j), 1 );
138 for (OrdinalType j=0; j<B_nrowcols; ++j)
139 for (OrdinalType i=0; i<=j; ++i)
140 blas.
GEMV( transw, 1, A_nrowcols, one, &AW(i,0), AW.
stride(), &W(j,0), W.
stride(), zero, &
B(i,j), 1 );
143 for (OrdinalType j=0; j<B_nrowcols; ++j)
144 for (OrdinalType i=j; i<B_nrowcols; ++i)
145 blas.
GEMV( transw, 1, A_nrowcols, one, &AW(i,0), AW.
stride(), &W(j,0), W.
stride(), zero, &
B(i,j), 1 );
161template<
typename OrdinalType,
typename ScalarType>
177template<
typename OrdinalType,
typename ScalarType>
179 const OrdinalType col,
182 if (v.
length() !=
A.numRows())
return false;
194template <
typename OrdinalType,
typename ScalarType>
201 MPI_Initialized(&mpiStarted);
210 const OrdinalType procRank = rank(*comm);
220 broadcast(*comm, 0,
A.numRows()*
A.numCols(), newMatrix.
values());
223 A.assign( newMatrix );
237template<
typename OrdinalType,
typename ScalarType>
240 const OrdinalType kl,
const OrdinalType ku,
241 const bool factorFormat)
243 OrdinalType m =
A->numRows();
244 OrdinalType n =
A->numCols();
248 "SerialBandDenseSolver<T>::generalToBanded: A is an empty SerialDenseMatrix<T>!");
250 "SerialBandDenseSolver<T>::generalToBanded: The lower bandwidth kl is invalid!");
252 "SerialBandDenseSolver<T>::generalToBanded: The upper bandwidth ku is invalid!");
254 OrdinalType extraBands = (factorFormat ? kl : 0);
258 for (OrdinalType j = 0; j < n; j++) {
260 (*AB)(i,j) = (*
A)(i,j);
273template<
typename OrdinalType,
typename ScalarType>
278 OrdinalType m = AB->numRows();
279 OrdinalType n = AB->numCols();
280 OrdinalType kl = AB->lowerBandwidth();
281 OrdinalType ku = AB->upperBandwidth();
285 "SerialBandDenseSolver<T>::bandedToGeneral: AB is an empty SerialBandDenseMatrix<T>!");
288 for (OrdinalType j = 0; j < n; j++) {
290 (*A)(i,j) = (*AB)(i,j);
Teuchos header file which uses auto-configuration information to include necessary C++ headers.
#define TEUCHOS_MIN(x, y)
#define TEUCHOS_MAX(x, y)
Teuchos::DataAccess Mode enumerable type.
Defines basic traits for the scalar field type.
Templated serial dense matrix class.
Templated serial dense matrix class.
Templated serial dense vector class.
Templated serial, dense, symmetric matrix class.
void GEMV(ETransp trans, const OrdinalType &m, const OrdinalType &n, const alpha_type alpha, const A_type *A, const OrdinalType &lda, const x_type *x, const OrdinalType &incx, const beta_type beta, ScalarType *y, const OrdinalType &incy) const
Performs the matrix-vector operation: y <- alpha*A*x+beta*y or y <- alpha*A'*x+beta*y where A is a ge...
static Teuchos::RCP< const Comm< OrdinalType > > getComm()
Return the default global communicator.
Smart reference counting pointer class for automatic garbage collection.
This class creates and provides basic support for banded dense matrices of templated type.
Teuchos::RCP< SerialBandDenseMatrix< OrdinalType, ScalarType > > generalToBanded(const RCP< SerialDenseMatrix< OrdinalType, ScalarType > > &A, const OrdinalType kl, const OrdinalType ku, const bool factorFormat)
A templated, non-member, helper function for converting a SerialDenseMatrix to a SerialBandDenseMatri...
Teuchos::RCP< SerialDenseMatrix< OrdinalType, ScalarType > > bandedToGeneral(const RCP< SerialBandDenseMatrix< OrdinalType, ScalarType > > &AB)
A templated, non-member, helper function for converting a SerialBandDenseMatrix to a SerialDenseMatri...
Concrete serial communicator subclass.
This class creates and provides basic support for dense rectangular matrix of templated type.
int putScalar(const ScalarType value=Teuchos::ScalarTraits< ScalarType >::zero())
Set all values in the matrix to a constant value.
void randomSyncedMatrix(Teuchos::SerialDenseMatrix< OrdinalType, ScalarType > &A)
A templated, non-member, helper function for generating a random SerialDenseMatrix that is synchroniz...
bool setCol(const SerialDenseVector< OrdinalType, ScalarType > &v, const OrdinalType col, SerialDenseMatrix< OrdinalType, ScalarType > &A)
A templated, non-member, helper function for setting a SerialDenseMatrix column using a SerialDenseVe...
OrdinalType stride() const
Returns the stride between the columns of this matrix in memory.
int random()
Set all values in the matrix to be random numbers.
OrdinalType numRows() const
Returns the row dimension of this matrix.
ScalarType * values() const
Data array access method.
int shapeUninitialized(OrdinalType numRows, OrdinalType numCols)
Same as shape() except leaves uninitialized.
int multiply(ETransp transa, ETransp transb, ScalarType alpha, const SerialDenseMatrix< OrdinalType, ScalarType > &A, const SerialDenseMatrix< OrdinalType, ScalarType > &B, ScalarType beta)
Multiply A * B and add them to this; this = beta * this + alpha*A*B.
OrdinalType numCols() const
Returns the column dimension of this matrix.
SerialDenseVector< OrdinalType, ScalarType > getCol(DataAccess CV, SerialDenseMatrix< OrdinalType, ScalarType > &A, const OrdinalType col)
A templated, non-member, helper function for viewing or copying a column of a SerialDenseMatrix as a ...
This class creates and provides basic support for dense vectors of templated type as a specialization...
OrdinalType length() const
Returns the length of this vector.
This class creates and provides basic support for symmetric, positive-definite dense matrices of temp...
void symMatTripleProduct(ETransp transw, const ScalarType alpha, const SerialSymDenseMatrix< OrdinalType, ScalarType > &A, const SerialDenseMatrix< OrdinalType, ScalarType > &W, SerialSymDenseMatrix< OrdinalType, ScalarType > &B)
A templated, non-member, helper function for computing the matrix triple-product: B = alpha*W^T*A*W o...
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
Macro for throwing an exception with breakpointing to ease debugging.
TEUCHOSNUMERICS_LIB_DLL_EXPORT const char ETranspChar[]
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
Deprecated.
This structure defines some basic traits for a scalar field type.
static T one()
Returns representation of one for this scalar type.
static T zero()
Returns representation of zero for this scalar type.