MOOCHO (Single Doxygen Collection)
Version of the Day
|
Test function for COOMatrix and COOMatrixSlice. More...
Namespaces | |
LinAlgPackIO | |
MatlabPack | |
TestingPack | |
Testing | |
Classes | |
class | NaNInfException |
class | DMatrixSliceTriEle |
class | DMatrixSliceTri |
class | DMatrixSliceSym |
class | DMatrixSlice |
class | DMatrix |
class | VectorSliceTmpl |
class | VectorTmpl |
class | IVector |
Typedefs | |
typedef long double | extended_value_type |
typedef FortranTypes::f_dbl_prec | value_type |
Typedef for the value type of elements that is used for the library. More... | |
typedef Teuchos::Ordinal | index_type |
Typedef for the index type of elements that are used by the library. More... | |
typedef Teuchos::Ordinal | size_type |
Typedef for the size type of elements that are used by the library. More... | |
Functions | |
bool | assert_print_nan_inf (const value_type &val, const std::string &name, bool throw_excpt, std::ostream *out) |
bool | assert_print_nan_inf (const DVectorSlice &v, const std::string &name, bool throw_excpt, std::ostream *out) |
bool | assert_print_nan_inf (const DMatrixSlice &m, const std::string &name, bool throw_excpt, std::ostream *out) |
void | delete_row_col (size_type kd, DMatrixSliceTriEle *M) |
void | resize_gm_lhs (DMatrix *gm_rhs, size_type rows, size_type cols, BLAS_Cpp::Transp trans_rhs) |
Utility to resize a DMatrix to the size of a rhs matrix. More... | |
std::istream & | operator>> (std::istream &is, DMatrix &gm) |
std::istream & | operator>> (std::istream &is, DMatrixSlice &gms) |
std::ostream & | operator<< (std::ostream &os, const DMatrixSlice &gms) |
std::ostream & | output (std::ostream &os, const DMatrixSlice &gms, LinAlgPackIO::fmtflags extra_flags) |
std::istream & | operator>> (std::istream &is, DVector &v) |
std::istream & | operator>> (std::istream &is, DVectorSlice &vs) |
std::ostream & | operator<< (std::ostream &os, const DVectorSlice &vs) |
std::ostream & | output (std::ostream &os, const DVectorSlice &vs, LinAlgPackIO::fmtflags extra_flags) |
DVector | e_vec (size_type i, size_type n) |
creates an n sized vector with all zeros accepts the ith element is one. More... | |
DMatrix | eye (size_type n) |
creates an n x n identity matrix More... | |
template<class T > | |
std::istream & | operator>> (std::istream &is, const LinAlgPackIO::bound_format< T > &bf) |
void | update_chol_factor (DMatrixSlice *UpTriM, DVectorSlice *u, const DVectorSlice &v) |
void | jacobi_rotate (DMatrixSlice *UpTriM, size_type row_i, value_type alpha, value_type beta) |
template<class T > | |
std::ostream & | operator<< (std::ostream &os, const LinAlgPackIO::const_bound_format< T > &bf) |
template<class T > | |
std::ostream & | operator<< (std::ostream &os, const LinAlgPackIO::bound_format< T > &bf) |
Force a type conversion from #bound_format<T># to #const_bound_format<T># to call operator<<#(). More... | |
std::istream & | operator>> (std::istream &istrm, IVector &perm) |
std::ostream & | operator<< (std::ostream &o, const IVector &perm) |
void | identity_perm (IVector *perm) |
void | inv_perm (const IVector &perm, IVector *inv_perm) |
void | perm_ele (const IVector &perm, DVectorSlice *vs) |
Permute a DVectorSlice in place. More... | |
void | perm_ele (const DVectorSlice &x, const IVector &perm, DVectorSlice *y) |
Perform y = P*x. More... | |
void | inv_perm_ele (const DVectorSlice &y, const IVector &perm, DVectorSlice *x) |
Perform x = P'*y. More... | |
void | perm_rows (const IVector &row_perm, DMatrixSlice *gms) |
Permute a GenMatrixSlices rows. More... | |
void | perm_cols (const IVector &col_perm, DMatrixSlice *gms) |
Permute a GenMatrixSlices columns. More... | |
void | perm_rows_cols (const IVector &row_perm, const IVector &col_perm, DMatrixSlice *gms) |
Permute a GenMatrixSlices rows and columns. More... | |
void | seed_random_vector_generator (unsigned int) |
void | random_vector (value_type l, value_type u, DVectorSlice *v) |
void | Vp_V_assert_sizes (size_type v_lhs_size, size_type v_rhs_size) |
v_lhs += op v_rhs More... | |
void | VopV_assert_sizes (size_type v_rhs1_size, size_type v_rhs2_size) |
v_rhs1 op v_rhs2 More... | |
void | Mp_M_assert_sizes (size_type m_lhs_rows, size_type m_lhs_cols, BLAS_Cpp::Transp trans_lhs, size_type m_rhs_rows, size_type m_rhs_cols, BLAS_Cpp::Transp trans_rhs) |
op(m_lhs) += op op(m_rhs) More... | |
void | MopM_assert_sizes (size_type m_rhs1_rows, size_type m_rhs1_cols, BLAS_Cpp::Transp trans_rhs1, size_type m_rhs2_rows, size_type m_rhs2_cols, BLAS_Cpp::Transp trans_rhs2) |
v_rhs1 op v_rhs2 More... | |
void | MtV_assert_sizes (size_type m_rhs1_rows, size_type m_rhs1_cols, BLAS_Cpp::Transp trans_rhs1, size_type v_rhs2_size) |
op(m_rhs1) * v_rhs2 More... | |
void | Vp_MtV_assert_sizes (size_type v_lhs_size, size_type m_rhs1_rows, size_type m_rhs1_cols, BLAS_Cpp::Transp trans_rhs1, size_type v_rhs2_size) |
v_lhs += op(m_rhs1) * v_rhs2 More... | |
void | MtM_assert_sizes (size_type m_rhs1_rows, size_type m_rhs1_cols, BLAS_Cpp::Transp trans_rhs1, size_type m_rhs2_rows, size_type m_rhs2_cols, BLAS_Cpp::Transp trans_rhs2) |
op(m_lhs) += op(m_rhs1) More... | |
void | Mp_MtM_assert_sizes (size_type m_lhs_rows, size_type m_lhs_cols, BLAS_Cpp::Transp trans_lhs, size_type m_rhs1_rows, size_type m_rhs1_cols, BLAS_Cpp::Transp trans_rhs1, size_type m_rhs2_rows, size_type m_rhs2_cols, BLAS_Cpp::Transp trans_rhs2) |
op(m_lhs) += op(m_rhs1) * op(m_rhs2) More... | |
void | assign (DMatrix *gm_lhs, value_type alpha) |
gm_lhs = alpha (elementwise) More... | |
void | assign (DMatrix *gm_lhs, const DMatrixSlice &gms_rhs, BLAS_Cpp::Transp trans_rhs) |
gm_lhs = op(gms_rhs) More... | |
void | assign (DMatrixSlice *gms_lhs, value_type alpha) |
gms_lhs = alpha (elementwise) More... | |
void | assign (DMatrixSlice *gms_lhs, const DMatrixSlice &gms_rhs, BLAS_Cpp::Transp trans_rhs) |
gms_lhs = op(gms_rhs) More... | |
void | assign (DMatrixSliceTriEle *tri_gms_lhs, value_type alpha) |
tri_ele_gms_lhs = alpha (elementwise) More... | |
void | assign (DMatrixSliceTriEle *tri_ele_gms_lhs, const DMatrixSliceTriEle &tri_ele_gms_rhs) |
tri_ele_gms_lhs = tri_ele_gms_rhs More... | |
DMatrixSliceTriEle | nonconst_tri_ele (DMatrixSlice gms, BLAS_Cpp::Uplo uplo) |
Return a triangular element-wise matrix. More... | |
const DMatrixSliceTriEle | tri_ele (const DMatrixSlice &gms, BLAS_Cpp::Uplo uplo) |
DMatrixSliceTri | nonconst_tri (DMatrixSlice gms, BLAS_Cpp::Uplo uplo, BLAS_Cpp::Diag diag) |
Return a triangular matrix. More... | |
const DMatrixSliceTri | tri (const DMatrixSlice &gms, BLAS_Cpp::Uplo uplo, BLAS_Cpp::Diag diag) |
DMatrixSliceSym | nonconst_sym (DMatrixSlice gms, BLAS_Cpp::Uplo uplo) |
Return a symmetric matrix. More... | |
const DMatrixSliceSym | sym (const DMatrixSlice &gms, BLAS_Cpp::Uplo uplo) |
void | assert_gms_sizes (const DMatrixSlice &gms1, BLAS_Cpp::Transp trans1, const DMatrixSlice &gms2, BLAS_Cpp::Transp trans2) |
Assert two matrices are the same size and throws length_error if they are not (LINALGPACK_CHECK_RHS_SIZES). More... | |
void | assert_gms_square (const DMatrixSlice &gms) |
Assert a matrix is square and throws length_error if it is not (LINALGPACK_CHECK_SLICE_SETUP). More... | |
void | assert_gms_lhs (const DMatrixSlice &gms_lhs, size_type rows, size_type cols, BLAS_Cpp::Transp trans_rhs=BLAS_Cpp::no_trans) |
DVectorSlice | row (DMatrixSlice &gms, BLAS_Cpp::Transp trans, size_type i) |
DVectorSlice | col (DMatrixSlice &gms, BLAS_Cpp::Transp trans, size_type j) |
const DVectorSlice | row (const DMatrixSlice &gms, BLAS_Cpp::Transp trans, size_type i) |
const DVectorSlice | col (const DMatrixSlice &gms, BLAS_Cpp::Transp trans, size_type j) |
DVectorSlice | row (DMatrix &gm, BLAS_Cpp::Transp trans, size_type i) |
DVectorSlice | col (DMatrix &gm, BLAS_Cpp::Transp trans, size_type j) |
const DVectorSlice | row (const DMatrix &gm, BLAS_Cpp::Transp trans, size_type i) |
const DVectorSlice | col (const DMatrix &gm, BLAS_Cpp::Transp trans, size_type j) |
std::istream & | input (std::istream &is, DMatrix *gm, LinAlgPackIO::fmtflags extra_flags) |
std::istream & | input (std::istream &is, DMatrixSlice *gms, LinAlgPackIO::fmtflags extra_flags) |
void | Mt_S (DMatrixSlice *gms_lhs, value_type alpha) |
gms_lhs *= alpha (BLAS xSCAL) More... | |
void | M_diagVtM (DMatrixSlice *gms_lhs, const DVectorSlice &vs_rhs, const DMatrixSlice &gms_rhs, BLAS_Cpp::Transp trans_rhs) |
gms_lhs = diag(vs_rhs) * op(gms_rhs) [Row or column scaling] More... | |
void | Mt_S (DMatrixSliceTriEle *tri_lhs, value_type alpha) |
tri_lhs *= alpha (BLAS xSCAL) More... | |
void | Mp_StM (DMatrixSliceTriEle *tri_lhs, value_type alpha, const DMatrixSliceTriEle &tri_rhs) |
tri_lhs += alpha * tri_rhs (BLAS xAXPY) More... | |
void | Mp_StM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSlice &gms_rhs, BLAS_Cpp::Transp trans_rhs) |
gms_lhs += alpha * op(gms_rhs) (BLAS xAXPY) More... | |
void | Mp_StM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSliceSym &sym_rhs, BLAS_Cpp::Transp trans_rhs) |
gms_lhs += alpha * op(sym_rhs) (BLAS xAXPY) More... | |
void | Mp_StM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSliceTri &tri_rhs, BLAS_Cpp::Transp trans_rhs) |
gms_lhs += alpha * op(tri_rhs) (BLAS xAXPY) More... | |
void | Vp_StMtV (DVectorSlice *vs_lhs, value_type alpha, const DMatrixSlice &gms_rhs1, BLAS_Cpp::Transp trans_rhs1, const DVectorSlice &vs_rhs2, value_type beta=1.0) |
vs_lhs = alpha * op(gms_rhs1) * vs_rhs2 + beta * vs_lhs (BLAS xGEMV) More... | |
void | Vp_StMtV (DVectorSlice *vs_lhs, value_type alpha, const DMatrixSliceSym &sym_rhs1, BLAS_Cpp::Transp trans_rhs1, const DVectorSlice &vs_rhs2, value_type beta=1.0) |
void | V_MtV (DVector *v_lhs, const DMatrixSliceTri &tri_rhs1, BLAS_Cpp::Transp trans_rhs1, const DVectorSlice &vs_rhs2) |
void | V_MtV (DVectorSlice *vs_lhs, const DMatrixSliceTri &tri_rhs1, BLAS_Cpp::Transp trans_rhs1, const DVectorSlice &vs_rhs2) |
void | Vp_StMtV (DVectorSlice *vs_lhs, value_type alpha, const DMatrixSliceTri &tri_rhs1, BLAS_Cpp::Transp trans_rhs1, const DVectorSlice &vs_rhs2, value_type beta=1.0) |
void | V_InvMtV (DVector *v_lhs, const DMatrixSliceTri &tri_rhs1, BLAS_Cpp::Transp trans_rhs1, const DVectorSlice &vs_rhs2) |
void | V_InvMtV (DVectorSlice *vs_lhs, const DMatrixSliceTri &tri_rhs1, BLAS_Cpp::Transp trans_rhs1, const DVectorSlice &vs_rhs2) |
void | ger (value_type alpha, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2, DMatrixSlice *gms_lhs) |
void | syr (value_type alpha, const DVectorSlice &vs_rhs, DMatrixSliceSym *sym_lhs) |
void | syr2 (value_type alpha, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2, DMatrixSliceSym *sym_lhs) |
void | Mp_StMtM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSlice &gms_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSlice &gms_rhs2, BLAS_Cpp::Transp trans_rhs2, value_type beta=1.0) |
void | Mp_StMtM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSliceSym &sym_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSlice &gms_rhs2, BLAS_Cpp::Transp trans_rhs2, value_type beta=1.0) |
void | Mp_StMtM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSlice &gms_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSliceSym &sym_rhs2, BLAS_Cpp::Transp trans_rhs2, value_type beta=1.0) |
void | syrk (BLAS_Cpp::Transp trans, value_type alpha, const DMatrixSlice &gms_rhs, value_type beta, DMatrixSliceSym *sym_lhs) |
void | syr2k (BLAS_Cpp::Transp trans, value_type alpha, const DMatrixSlice &gms_rhs1, const DMatrixSlice &gms_rhs2, value_type beta, DMatrixSliceSym *sym_lhs) |
void | M_StMtM (DMatrix *gm_lhs, value_type alpha, const DMatrixSliceTri &tri_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSlice &gms_rhs2, BLAS_Cpp::Transp trans_rhs2) |
void | M_StMtM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSliceTri &tri_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSlice &gms_rhs2, BLAS_Cpp::Transp trans_rhs2) |
void | M_StMtM (DMatrix *gm_lhs, value_type alpha, const DMatrixSlice &gms_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSliceTri &tri_rhs2, BLAS_Cpp::Transp trans_rhs2) |
void | M_StMtM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSlice &gms_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSliceTri &tri_rhs2, BLAS_Cpp::Transp trans_rhs2) |
void | Mp_StMtM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSliceTri &tri_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSlice &gms_rhs2, BLAS_Cpp::Transp trans_rhs2, value_type beta=1.0) |
void | Mp_StMtM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSlice &gms_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSliceTri &tri_rhs2, BLAS_Cpp::Transp trans_rhs2, value_type beta=1.0) |
void | M_StInvMtM (DMatrix *gm_lhs, value_type alpha, const DMatrixSliceTri &tri_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSlice &gms_rhs2, BLAS_Cpp::Transp trans_rhs2) |
void | M_StInvMtM (DMatrixSlice *gms_lhs, value_type alpha, const DMatrixSliceTri &tri_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSlice &gms_rhs2, BLAS_Cpp::Transp trans_rhs2) |
void | M_StMtInvM (DMatrix *gm_lhs, value_type alpha, const DMatrixSlice &gms_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSliceTri &tri_rhs2, BLAS_Cpp::Transp trans_rhs2) |
void | M_StMtInvM (DMatrixSlice *gm_lhs, value_type alpha, const DMatrixSlice &gms_rhs1, BLAS_Cpp::Transp trans_rhs1, const DMatrixSliceTri &tri_rhs2, BLAS_Cpp::Transp trans_rhs2) |
void | assign (DVector *v_lhs, value_type alpha) |
v_lhs = alpha (elementwise) More... | |
void | assign (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = vs_rhs. More... | |
void | assign (DVectorSlice *vs_lhs, value_type alpha) |
vs_lhs = alpha (elementwise) More... | |
void | assign (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = vs_rhs More... | |
size_type | vector_validate_sized (size_type size) |
void | vector_validate_range (size_type ubound, size_type max_ubound) |
void | vector_validate_subscript (size_type size, size_type i) |
void | assert_vs_sizes (size_type size1, size_type size2) |
template<class T > | |
VectorSliceTmpl< T > | gen_vs (VectorSliceTmpl< T > &vs, size_type start, size_type size, ptrdiff_t stride) |
template<class T > | |
const VectorSliceTmpl< T > | gen_vs (const VectorSliceTmpl< T > &vs, size_type start, size_type size, ptrdiff_t stride) |
std::istream & | input (std::istream &is, DVector *v, LinAlgPackIO::fmtflags extra_flags) |
std::istream & | input (std::istream &is, DVectorSlice *vs, LinAlgPackIO::fmtflags extra_flags) |
void | Vp_S (DVectorSlice *vs_lhs, value_type alpha) |
vs_lhs += alpha More... | |
void | Vt_S (DVectorSlice *vs_lhs, value_type alpha) |
vs_lhs *= alpha (BLAS xSCAL) (*** Note that alpha == 0.0 is handeled as vs_lhs = 0.0) More... | |
void | Vp_StV (DVectorSlice *vs_lhs, value_type alpha, const DVectorSlice &vs_rhs) |
vs_lhs += alpha * vs_rhs (BLAS xAXPY) More... | |
void | V_VpV (DVector *v_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
v_lhs = alpha (elementwise) More... | |
void | V_VmV (DVector *v_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
v_lhs = vs_rhs1 - vs_rhs2 More... | |
void | V_mV (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = - vs_rhs More... | |
void | V_StV (DVector *v_lhs, value_type alpha, const DVectorSlice &vs_rhs) |
v_lhs = alpha * vs_rhs More... | |
void | V_VpV (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
vs_lhs = alpha (elementwise) More... | |
void | V_VmV (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
vs_lhs = vs_rhs1 - vs_rhs2 More... | |
void | V_mV (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = - vs_rhs More... | |
void | V_StV (DVectorSlice *vs_lhs, value_type alpha, const DVectorSlice &vs_rhs) |
vs_lhs = alpha * vs_rhs More... | |
void | rot (const value_type c, const value_type s, DVectorSlice *x, DVectorSlice *y) |
void | abs (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = abs(vs_rhs) More... | |
void | asin (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = asin(vs_rhs) More... | |
void | acos (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = acos(vs_rhs) More... | |
void | atan (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = atan(vs_rhs) More... | |
void | atan2 (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
vs_lhs = atan(vs_rhs1/vs_rhs2) More... | |
void | atan2 (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs, value_type alpha) |
vs_lhs = atan(vs_rhs/alpha) More... | |
void | atan2 (DVectorSlice *vs_lhs, value_type alpha, const DVectorSlice &vs_rhs) |
vs_lhs = atan(alpha/vs_rhs) More... | |
void | cos (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = cos(vs_rhs) More... | |
void | cosh (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = cosh(vs_rhs) More... | |
void | exp (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = exp(vs_rhs) More... | |
void | max (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
vs_lhs = max(vs_rhs1,vs_rhs2) More... | |
void | max (DVectorSlice *vs_lhs, value_type alpha, const DVectorSlice &vs_rhs) |
vs_lhs = max(alpha,vs_rhs) More... | |
void | min (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
vs_lhs = min(vs_rhs1,vs_rhs2) More... | |
void | min (DVectorSlice *vs_lhs, value_type alpha, const DVectorSlice &vs_rhs) |
vs_lhs = mim(alpha,vs_rhs) More... | |
void | pow (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
vs_lhs = pow(vs_rhs1,vs_rhs2) More... | |
void | pow (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs, value_type alpha) |
vs_lhs = pow(vs_rhs,alpha) More... | |
void | pow (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs, int n) |
vs_lhs = pow(vs_rhs,n) More... | |
void | pow (DVectorSlice *vs_lhs, value_type alpha, const DVectorSlice &vs_rhs) |
vs_lhs = pow(alpha,vs_rhs) More... | |
void | prod (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
vs_lhs(i) = vs_rhs1(i) * vs_rhs2(i), i = 1...n More... | |
void | sqrt (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = sqrt(vs_rhs) More... | |
void | sin (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = sin(vs_rhs) More... | |
void | sinh (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = sinh(vs_rhs) More... | |
void | tan (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = tan(vs_rhs) More... | |
void | tanh (DVectorSlice *vs_lhs, const DVectorSlice &vs_rhs) |
vs_lhs = tanh(vs_rhs) More... | |
void | abs (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = abs(vs_rhs) More... | |
void | asin (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = asin(vs_rhs) More... | |
void | acos (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = acos(vs_rhs) More... | |
void | atan (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = atan(vs_rhs) More... | |
void | atan2 (DVector *v_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
v_lhs = atan(vs_rhs1/vs_rhs2) More... | |
void | atan2 (DVector *v_lhs, const DVectorSlice &vs_rhs, value_type alpha) |
v_lhs = atan(vs_rhs/alpha) More... | |
void | atan2 (DVector *v_lhs, value_type alpha, const DVectorSlice &vs_rhs) |
v_lhs = atan(alpha/vs_rhs) More... | |
void | cos (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = cos(vs_rhs) More... | |
void | cosh (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = cosh(vs_rhs) More... | |
void | exp (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = exp(vs_rhs) More... | |
void | max (DVector *v_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
v_lhs = max(vs_rhs1,vs_rhs2) More... | |
void | max (DVector *v_lhs, value_type alpha, const DVectorSlice &vs_rhs) |
v_lhs = max(alpha,vs_rhs) More... | |
void | min (DVector *v_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
v_lhs = min(vs_rhs1,vs_rhs2) More... | |
void | min (DVector *v_lhs, value_type alpha, const DVectorSlice &vs_rhs) |
v_lhs = mim(alpha,vs_rhs) More... | |
void | pow (DVector *v_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
v_lhs = pow(vs_rhs1,vs_rhs2) More... | |
void | pow (DVector *v_lhs, const DVectorSlice &vs_rhs, value_type alpha) |
v_lhs = pow(vs_rhs,alpha) More... | |
void | pow (DVector *v_lhs, const DVectorSlice &vs_rhs, int n) |
v_lhs = pow(vs_rhs,n) More... | |
void | pow (DVector *v_lhs, value_type alpha, const DVectorSlice &vs_rhs2) |
v_lhs = pow(alpha,vs_rhs) More... | |
void | sqrt (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = sqrt(vs_rhs) More... | |
void | sin (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = sin(vs_rhs) More... | |
void | sinh (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = sinh(vs_rhs) More... | |
void | tan (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = tan(vs_rhs) More... | |
void | tanh (DVector *v_lhs, const DVectorSlice &vs_rhs) |
v_lhs = tanh(vs_rhs) More... | |
void | prod (DVector *vs_lhs, const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
v_lhs(i) = vs_rhs1(i) * vs_rhs2(i), i = 1...n More... | |
value_type | dot (const DVectorSlice &vs_rhs1, const DVectorSlice &vs_rhs2) |
result = vs_rhs1' * vs_rhs2 (BLAS xDOT) More... | |
value_type | max (const DVectorSlice &vs_rhs) |
result = max(vs_rhs) More... | |
value_type | min (const DVectorSlice &vs_rhs) |
result = min(vs_rhs) More... | |
value_type | norm_1 (const DVectorSlice &vs_rhs) |
result = ||vs_rhs||1 (BLAS xASUM) More... | |
value_type | norm_2 (const DVectorSlice &vs_rhs) |
result = ||vs_rhs||2 (BLAS xNRM2) More... | |
value_type | norm_inf (const DVectorSlice &vs_rhs) |
result = ||vs_rhs||infinity (BLAS IxAMAX) More... | |
void | swap (DVectorSlice *vs1, DVectorSlice *vs2) |
swap(vs1, vs2). Swaps the contents of vs1 and vs2 More... | |
const value_type | sqrt_eps = ::sqrt(std::numeric_limits<value_type>::epsilon()) |
bool | comp (const DVectorSlice &vs1, const DVectorSlice &vs2) |
bool | comp (const DVectorSlice &vs, value_type alpha) |
bool | comp (const DMatrixSlice &gms1, BLAS_Cpp::Transp trans1, const DMatrixSlice &gms2, BLAS_Cpp::Transp trans2) |
bool | comp (const DMatrixSlice &gms1, const DMatrixSlice &gms2) |
bool | comp (const DMatrixSlice &gms1, value_type alpha) |
bool | comp (const DMatrixSliceTriEle &tri_gms1, const DMatrixSliceTriEle &tri_gms2) |
bool | comp (const DMatrixSliceTriEle &tri_gms1, value_type alpha) |
bool | comp_less (const DVectorSlice &vs, value_type alpha) |
enum | EOverLap { NO_OVERLAP = 0, SOME_OVERLAP, SAME_MEM } |
Enumeration for returning the amount of overlap between two objects. More... | |
typedef VectorTmpl < extended_value_type > | VectorExt |
typedef VectorSliceTmpl < extended_value_type > | VectorSliceExt |
typedef VectorTmpl< value_type > | DVector |
typedef VectorSliceTmpl < value_type > | DVectorSlice |
Test function for COOMatrix and COOMatrixSlice.
Definition at line 51 of file DenseLinAlgPack_DVectorClassExt.hpp.
Definition at line 52 of file DenseLinAlgPack_DVectorClassExt.hpp.
typedef long double DenseLinAlgPack::extended_value_type |
Definition at line 47 of file DenseLinAlgPack_extended_value_type.hpp.
typedef FortranTypes::f_dbl_prec DenseLinAlgPack::value_type |
Typedef for the value type of elements that is used for the library.
Definition at line 100 of file DenseLinAlgPack_Options.hpp.
typedef Teuchos::Ordinal DenseLinAlgPack::index_type |
Typedef for the index type of elements that are used by the library.
Definition at line 102 of file DenseLinAlgPack_Options.hpp.
typedef Teuchos::Ordinal DenseLinAlgPack::size_type |
Typedef for the size type of elements that are used by the library.
Definition at line 104 of file DenseLinAlgPack_Options.hpp.
typedef VectorTmpl<value_type> DenseLinAlgPack::DVector |
Definition at line 90 of file DenseLinAlgPack_Types.hpp.
Definition at line 94 of file DenseLinAlgPack_Types.hpp.
Enumeration for returning the amount of overlap between two objects.
Enumerator | |
---|---|
NO_OVERLAP | |
SOME_OVERLAP | |
SAME_MEM |
Definition at line 81 of file DenseLinAlgPack_Types.hpp.
bool DenseLinAlgPack::assert_print_nan_inf | ( | const value_type & | val, |
const std::string & | name, | ||
bool | throw_excpt, | ||
std::ostream * | out | ||
) |
Definition at line 51 of file DenseLinAlgPack_assert_print_nan_inf.cpp.
bool DenseLinAlgPack::assert_print_nan_inf | ( | const DVectorSlice & | v, |
const std::string & | name, | ||
bool | throw_excpt, | ||
std::ostream * | out | ||
) |
Definition at line 73 of file DenseLinAlgPack_assert_print_nan_inf.cpp.
bool DenseLinAlgPack::assert_print_nan_inf | ( | const DMatrixSlice & | m, |
const std::string & | name, | ||
bool | throw_excpt, | ||
std::ostream * | out | ||
) |
Definition at line 109 of file DenseLinAlgPack_assert_print_nan_inf.cpp.
void DenseLinAlgPack::Vp_V_assert_sizes | ( | size_type | v_lhs_size, |
size_type | v_rhs_size | ||
) |
v_lhs += op v_rhs
Definition at line 50 of file DenseLinAlgPack_AssertOp.cpp.
void DenseLinAlgPack::VopV_assert_sizes | ( | size_type | v_rhs1_size, |
size_type | v_rhs2_size | ||
) |
v_rhs1 op v_rhs2
Definition at line 58 of file DenseLinAlgPack_AssertOp.cpp.
void DenseLinAlgPack::Mp_M_assert_sizes | ( | size_type | m_lhs_rows, |
size_type | m_lhs_cols, | ||
BLAS_Cpp::Transp | trans_lhs, | ||
size_type | m_rhs_rows, | ||
size_type | m_rhs_cols, | ||
BLAS_Cpp::Transp | trans_rhs | ||
) |
op(m_lhs) += op op(m_rhs)
Definition at line 66 of file DenseLinAlgPack_AssertOp.cpp.
void DenseLinAlgPack::MopM_assert_sizes | ( | size_type | m_rhs1_rows, |
size_type | m_rhs1_cols, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
size_type | m_rhs2_rows, | ||
size_type | m_rhs2_cols, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
v_rhs1 op v_rhs2
Definition at line 79 of file DenseLinAlgPack_AssertOp.cpp.
void DenseLinAlgPack::MtV_assert_sizes | ( | size_type | m_rhs1_rows, |
size_type | m_rhs1_cols, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
size_type | v_rhs2_size | ||
) |
op(m_rhs1) * v_rhs2
Definition at line 92 of file DenseLinAlgPack_AssertOp.cpp.
void DenseLinAlgPack::Vp_MtV_assert_sizes | ( | size_type | v_lhs_size, |
size_type | m_rhs1_rows, | ||
size_type | m_rhs1_cols, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
size_type | v_rhs2_size | ||
) |
v_lhs += op(m_rhs1) * v_rhs2
Definition at line 103 of file DenseLinAlgPack_AssertOp.cpp.
void DenseLinAlgPack::MtM_assert_sizes | ( | size_type | m_rhs1_rows, |
size_type | m_rhs1_cols, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
size_type | m_rhs2_rows, | ||
size_type | m_rhs2_cols, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
op(m_lhs) += op(m_rhs1)
Definition at line 120 of file DenseLinAlgPack_AssertOp.cpp.
void DenseLinAlgPack::Mp_MtM_assert_sizes | ( | size_type | m_lhs_rows, |
size_type | m_lhs_cols, | ||
BLAS_Cpp::Transp | trans_lhs, | ||
size_type | m_rhs1_rows, | ||
size_type | m_rhs1_cols, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
size_type | m_rhs2_rows, | ||
size_type | m_rhs2_cols, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
op(m_lhs) += op(m_rhs1) * op(m_rhs2)
Definition at line 132 of file DenseLinAlgPack_AssertOp.cpp.
void DenseLinAlgPack::delete_row_col | ( | size_type | kd, |
DMatrixSliceTriEle * | M | ||
) |
Definition at line 48 of file DenseLinAlgPack_delete_row_col.cpp.
gm_lhs = alpha (elementwise)
Definition at line 121 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::assign | ( | DMatrix * | gm_lhs, |
const DMatrixSlice & | gms_rhs, | ||
BLAS_Cpp::Transp | trans_rhs | ||
) |
gm_lhs = op(gms_rhs)
Definition at line 128 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::assign | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha | ||
) |
gms_lhs = alpha (elementwise)
Definition at line 145 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::assign | ( | DMatrixSlice * | gms_lhs, |
const DMatrixSlice & | gms_rhs, | ||
BLAS_Cpp::Transp | trans_rhs | ||
) |
gms_lhs = op(gms_rhs)
Definition at line 154 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::assign | ( | DMatrixSliceTriEle * | tri_gms_lhs, |
value_type | alpha | ||
) |
tri_ele_gms_lhs = alpha (elementwise)
Definition at line 161 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::assign | ( | DMatrixSliceTriEle * | tri_ele_gms_lhs, |
const DMatrixSliceTriEle & | tri_ele_gms_rhs | ||
) |
tri_ele_gms_lhs = tri_ele_gms_rhs
Definition at line 176 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
|
inline |
Return a triangular element-wise matrix.
Definition at line 112 of file DenseLinAlgPack_DMatrixAsTriSym.hpp.
|
inline |
Definition at line 119 of file DenseLinAlgPack_DMatrixAsTriSym.hpp.
|
inline |
Return a triangular matrix.
Definition at line 185 of file DenseLinAlgPack_DMatrixAsTriSym.hpp.
|
inline |
Definition at line 192 of file DenseLinAlgPack_DMatrixAsTriSym.hpp.
|
inline |
Return a symmetric matrix.
Definition at line 251 of file DenseLinAlgPack_DMatrixAsTriSym.hpp.
|
inline |
Definition at line 258 of file DenseLinAlgPack_DMatrixAsTriSym.hpp.
|
inline |
Assert two matrices are the same size and throws length_error if they are not (LINALGPACK_CHECK_RHS_SIZES).
Definition at line 191 of file DenseLinAlgPack_DMatrixClass.cpp.
|
inline |
Assert a matrix is square and throws length_error if it is not (LINALGPACK_CHECK_SLICE_SETUP).
Definition at line 663 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Definition at line 680 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Definition at line 694 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Definition at line 700 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Definition at line 706 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Definition at line 712 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Definition at line 718 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Definition at line 724 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Definition at line 730 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Definition at line 736 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Utility to resize a DMatrix to the size of a rhs matrix.
Definition at line 744 of file DenseLinAlgPack_DMatrixClass.hpp.
|
inline |
Definition at line 55 of file DenseLinAlgPack_DMatrixIn.hpp.
|
inline |
Definition at line 64 of file DenseLinAlgPack_DMatrixIn.hpp.
std::istream & DenseLinAlgPack::input | ( | std::istream & | is, |
DMatrix * | gm, | ||
LinAlgPackIO::fmtflags | extra_flags | ||
) |
Definition at line 53 of file DenseLinAlgPack_DMatrixInFunc.cpp.
std::istream & DenseLinAlgPack::input | ( | std::istream & | is, |
DMatrixSlice * | gms, | ||
LinAlgPackIO::fmtflags | extra_flags | ||
) |
Definition at line 70 of file DenseLinAlgPack_DMatrixInFunc.cpp.
void DenseLinAlgPack::Mt_S | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha | ||
) |
gms_lhs *= alpha (BLAS xSCAL)
Definition at line 215 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::M_diagVtM | ( | DMatrixSlice * | gms_lhs, |
const DVectorSlice & | vs_rhs, | ||
const DMatrixSlice & | gms_rhs, | ||
BLAS_Cpp::Transp | trans_rhs | ||
) |
gms_lhs = diag(vs_rhs) * op(gms_rhs) [Row or column scaling]
Definition at line 224 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Mt_S | ( | DMatrixSliceTriEle * | tri_lhs, |
value_type | alpha | ||
) |
tri_lhs *= alpha (BLAS xSCAL)
Definition at line 233 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Mp_StM | ( | DMatrixSliceTriEle * | tri_lhs, |
value_type | alpha, | ||
const DMatrixSliceTriEle & | tri_rhs | ||
) |
tri_lhs += alpha * tri_rhs (BLAS xAXPY)
Definition at line 245 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Mp_StM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs, | ||
BLAS_Cpp::Transp | trans_rhs | ||
) |
gms_lhs += alpha * op(gms_rhs) (BLAS xAXPY)
Definition at line 261 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Mp_StM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSliceSym & | sym_rhs, | ||
BLAS_Cpp::Transp | trans_rhs | ||
) |
gms_lhs += alpha * op(sym_rhs) (BLAS xAXPY)
Definition at line 289 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Mp_StM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSliceTri & | tri_rhs, | ||
BLAS_Cpp::Transp | trans_rhs | ||
) |
gms_lhs += alpha * op(tri_rhs) (BLAS xAXPY)
Definition at line 306 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Vp_StMtV | ( | DVectorSlice * | vs_lhs, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DVectorSlice & | vs_rhs2, | ||
value_type | beta = 1.0 |
||
) |
vs_lhs = alpha * op(gms_rhs1) * vs_rhs2 + beta * vs_lhs (BLAS xGEMV)
Definition at line 349 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Vp_StMtV | ( | DVectorSlice * | vs_lhs, |
value_type | alpha, | ||
const DMatrixSliceSym & | sym_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DVectorSlice & | vs_rhs2, | ||
value_type | beta = 1.0 |
||
) |
Definition at line 359 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::V_MtV | ( | DVector * | v_lhs, |
const DMatrixSliceTri & | tri_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
Definition at line 370 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::V_MtV | ( | DVectorSlice * | vs_lhs, |
const DMatrixSliceTri & | tri_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
Definition at line 381 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Vp_StMtV | ( | DVectorSlice * | vs_lhs, |
value_type | alpha, | ||
const DMatrixSliceTri & | tri_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DVectorSlice & | vs_rhs2, | ||
value_type | beta = 1.0 |
||
) |
Definition at line 392 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::V_InvMtV | ( | DVector * | v_lhs, |
const DMatrixSliceTri & | tri_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
Definition at line 413 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::V_InvMtV | ( | DVectorSlice * | vs_lhs, |
const DMatrixSliceTri & | tri_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
Definition at line 424 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::ger | ( | value_type | alpha, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2, | ||
DMatrixSlice * | gms_lhs | ||
) |
Definition at line 436 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::syr | ( | value_type | alpha, |
const DVectorSlice & | vs_rhs, | ||
DMatrixSliceSym * | sym_lhs | ||
) |
Definition at line 449 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::syr2 | ( | value_type | alpha, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2, | ||
DMatrixSliceSym * | sym_lhs | ||
) |
Definition at line 458 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Mp_StMtM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSlice & | gms_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2, | ||
value_type | beta = 1.0 |
||
) |
Definition at line 476 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Mp_StMtM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSliceSym & | sym_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSlice & | gms_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2, | ||
value_type | beta = 1.0 |
||
) |
Definition at line 509 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Mp_StMtM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSliceSym & | sym_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2, | ||
value_type | beta = 1.0 |
||
) |
Definition at line 527 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::syrk | ( | BLAS_Cpp::Transp | trans, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs, | ||
value_type | beta, | ||
DMatrixSliceSym * | sym_lhs | ||
) |
Definition at line 545 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::syr2k | ( | BLAS_Cpp::Transp | trans, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs1, | ||
const DMatrixSlice & | gms_rhs2, | ||
value_type | beta, | ||
DMatrixSliceSym * | sym_lhs | ||
) |
Definition at line 557 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::M_StMtM | ( | DMatrix * | gm_lhs, |
value_type | alpha, | ||
const DMatrixSliceTri & | tri_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSlice & | gms_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
Definition at line 627 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::M_StMtM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSliceTri & | tri_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSlice & | gms_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
Definition at line 638 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::M_StMtM | ( | DMatrix * | gm_lhs, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSliceTri & | tri_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
Definition at line 648 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::M_StMtM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSliceTri & | tri_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
Definition at line 659 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Mp_StMtM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSliceTri & | tri_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSlice & | gms_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2, | ||
value_type | beta = 1.0 |
||
) |
Definition at line 669 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::Mp_StMtM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSliceTri & | tri_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2, | ||
value_type | beta = 1.0 |
||
) |
Definition at line 688 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::M_StInvMtM | ( | DMatrix * | gm_lhs, |
value_type | alpha, | ||
const DMatrixSliceTri & | tri_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSlice & | gms_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
Definition at line 707 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::M_StInvMtM | ( | DMatrixSlice * | gms_lhs, |
value_type | alpha, | ||
const DMatrixSliceTri & | tri_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSlice & | gms_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
Definition at line 718 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::M_StMtInvM | ( | DMatrix * | gm_lhs, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSliceTri & | tri_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
Definition at line 728 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
void DenseLinAlgPack::M_StMtInvM | ( | DMatrixSlice * | gm_lhs, |
value_type | alpha, | ||
const DMatrixSlice & | gms_rhs1, | ||
BLAS_Cpp::Transp | trans_rhs1, | ||
const DMatrixSliceTri & | tri_rhs2, | ||
BLAS_Cpp::Transp | trans_rhs2 | ||
) |
Definition at line 739 of file DenseLinAlgPack_DMatrixOpBLAS.cpp.
|
inline |
Definition at line 54 of file DenseLinAlgPack_DMatrixOut.hpp.
std::ostream & DenseLinAlgPack::output | ( | std::ostream & | os, |
const DMatrixSlice & | gms, | ||
LinAlgPackIO::fmtflags | extra_flags | ||
) |
Definition at line 50 of file DenseLinAlgPack_DMatrixOutFunc.cpp.
v_lhs = alpha (elementwise)
Definition at line 283 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = vs_rhs.
Definition at line 290 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::assign | ( | DVectorSlice * | vs_lhs, |
value_type | alpha | ||
) |
vs_lhs = alpha (elementwise)
Definition at line 128 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::assign | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = vs_rhs
Definition at line 133 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
DenseLinAlgPack::size_type DenseLinAlgPack::vector_validate_sized | ( | size_type | size | ) |
Definition at line 48 of file DenseLinAlgPack_DVectorClassTmpl.cpp.
void DenseLinAlgPack::vector_validate_range | ( | size_type | ubound, |
size_type | max_ubound | ||
) |
Definition at line 59 of file DenseLinAlgPack_DVectorClassTmpl.cpp.
void DenseLinAlgPack::vector_validate_subscript | ( | size_type | size, |
size_type | i | ||
) |
Definition at line 68 of file DenseLinAlgPack_DVectorClassTmpl.cpp.
void DenseLinAlgPack::assert_vs_sizes | ( | size_type | size1, |
size_type | size2 | ||
) |
Definition at line 77 of file DenseLinAlgPack_DVectorClassTmpl.cpp.
|
inline |
Definition at line 780 of file DenseLinAlgPack_DVectorClassTmpl.hpp.
|
inline |
Definition at line 788 of file DenseLinAlgPack_DVectorClassTmpl.hpp.
|
inline |
Definition at line 55 of file DenseLinAlgPack_DVectorIn.hpp.
|
inline |
Definition at line 64 of file DenseLinAlgPack_DVectorIn.hpp.
std::istream & DenseLinAlgPack::input | ( | std::istream & | is, |
DVector * | v, | ||
LinAlgPackIO::fmtflags | extra_flags | ||
) |
Definition at line 52 of file DenseLinAlgPack_DVectorInFunc.cpp.
std::istream & DenseLinAlgPack::input | ( | std::istream & | is, |
DVectorSlice * | vs, | ||
LinAlgPackIO::fmtflags | extra_flags | ||
) |
Definition at line 65 of file DenseLinAlgPack_DVectorInFunc.cpp.
void DenseLinAlgPack::Vp_S | ( | DVectorSlice * | vs_lhs, |
value_type | alpha | ||
) |
vs_lhs += alpha
Definition at line 94 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::Vt_S | ( | DVectorSlice * | vs_lhs, |
value_type | alpha | ||
) |
vs_lhs *= alpha (BLAS xSCAL) (*** Note that alpha == 0.0 is handeled as vs_lhs = 0.0)
Definition at line 111 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::Vp_StV | ( | DVectorSlice * | vs_lhs, |
value_type | alpha, | ||
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs += alpha * vs_rhs (BLAS xAXPY)
Definition at line 120 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::V_VpV | ( | DVector * | v_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
v_lhs = alpha (elementwise)
v_lhs = vs_rhs. v_lhs = vs_rhs1 + vs_rhs2
Definition at line 294 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::V_VmV | ( | DVector * | v_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
v_lhs = vs_rhs1 - vs_rhs2
Definition at line 308 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = - vs_rhs
Definition at line 314 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = alpha * vs_rhs
Definition at line 319 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::V_VpV | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
vs_lhs = alpha (elementwise)
vs_lhs = vs_rhs vs_lhs = vs_rhs1 + vs_rhs2
Definition at line 137 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::V_VmV | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
vs_lhs = vs_rhs1 - vs_rhs2
Definition at line 142 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::V_mV | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = - vs_rhs
Definition at line 147 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::V_StV | ( | DVectorSlice * | vs_lhs, |
value_type | alpha, | ||
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = alpha * vs_rhs
Definition at line 152 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::rot | ( | const value_type | c, |
const value_type | s, | ||
DVectorSlice * | x, | ||
DVectorSlice * | y | ||
) |
Definition at line 325 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::abs | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = abs(vs_rhs)
Definition at line 191 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::asin | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = asin(vs_rhs)
Definition at line 194 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::acos | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = acos(vs_rhs)
Definition at line 197 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::atan | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = atan(vs_rhs)
Definition at line 200 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::atan2 | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
vs_lhs = atan(vs_rhs1/vs_rhs2)
Definition at line 203 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::atan2 | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs, | ||
value_type | alpha | ||
) |
vs_lhs = atan(vs_rhs/alpha)
Definition at line 206 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::atan2 | ( | DVectorSlice * | vs_lhs, |
value_type | alpha, | ||
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = atan(alpha/vs_rhs)
Definition at line 209 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::cos | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = cos(vs_rhs)
Definition at line 213 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::cosh | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = cosh(vs_rhs)
Definition at line 216 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::exp | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = exp(vs_rhs)
Definition at line 219 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::max | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
vs_lhs = max(vs_rhs1,vs_rhs2)
Definition at line 222 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::max | ( | DVectorSlice * | vs_lhs, |
value_type | alpha, | ||
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = max(alpha,vs_rhs)
Definition at line 230 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::min | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
vs_lhs = min(vs_rhs1,vs_rhs2)
Definition at line 236 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::min | ( | DVectorSlice * | vs_lhs, |
value_type | alpha, | ||
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = mim(alpha,vs_rhs)
Definition at line 244 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::pow | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
vs_lhs = pow(vs_rhs1,vs_rhs2)
Definition at line 250 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::pow | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs, | ||
value_type | alpha | ||
) |
vs_lhs = pow(vs_rhs,alpha)
Definition at line 253 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::pow | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs, | ||
int | n | ||
) |
vs_lhs = pow(vs_rhs,n)
Definition at line 256 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::pow | ( | DVectorSlice * | vs_lhs, |
value_type | alpha, | ||
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = pow(alpha,vs_rhs)
Definition at line 259 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::prod | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
vs_lhs(i) = vs_rhs1(i) * vs_rhs2(i), i = 1...n
Definition at line 262 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::sqrt | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = sqrt(vs_rhs)
Definition at line 265 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::sin | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = sin(vs_rhs)
Definition at line 268 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::sinh | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = sinh(vs_rhs)
Definition at line 271 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::tan | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = tan(vs_rhs)
Definition at line 274 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::tanh | ( | DVectorSlice * | vs_lhs, |
const DVectorSlice & | vs_rhs | ||
) |
vs_lhs = tanh(vs_rhs)
Definition at line 277 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = abs(vs_rhs)
Definition at line 361 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = asin(vs_rhs)
Definition at line 364 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = acos(vs_rhs)
Definition at line 367 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = atan(vs_rhs)
Definition at line 370 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::atan2 | ( | DVector * | v_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
v_lhs = atan(vs_rhs1/vs_rhs2)
Definition at line 373 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = atan(vs_rhs/alpha)
Definition at line 377 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = atan(alpha/vs_rhs)
Definition at line 380 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = cos(vs_rhs)
Definition at line 383 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = cosh(vs_rhs)
Definition at line 386 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = exp(vs_rhs)
Definition at line 389 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::max | ( | DVector * | v_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
v_lhs = max(vs_rhs1,vs_rhs2)
Definition at line 392 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = max(alpha,vs_rhs)
Definition at line 400 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::min | ( | DVector * | v_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
v_lhs = min(vs_rhs1,vs_rhs2)
Definition at line 406 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = mim(alpha,vs_rhs)
Definition at line 414 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::pow | ( | DVector * | v_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
v_lhs = pow(vs_rhs1,vs_rhs2)
Definition at line 420 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = pow(vs_rhs,alpha)
Definition at line 423 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = pow(vs_rhs,n)
Definition at line 426 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = pow(alpha,vs_rhs)
Definition at line 429 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = sqrt(vs_rhs)
Definition at line 435 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = sin(vs_rhs)
Definition at line 438 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = sinh(vs_rhs)
Definition at line 441 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = tan(vs_rhs)
Definition at line 444 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
v_lhs = tanh(vs_rhs)
Definition at line 447 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::prod | ( | DVector * | vs_lhs, |
const DVectorSlice & | vs_rhs1, | ||
const DVectorSlice & | vs_rhs2 | ||
) |
v_lhs(i) = vs_rhs1(i) * vs_rhs2(i), i = 1...n
Definition at line 432 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
DenseLinAlgPack::value_type DenseLinAlgPack::dot | ( | const DVectorSlice & | vs_rhs1, |
const DVectorSlice & | vs_rhs2 | ||
) |
result = vs_rhs1' * vs_rhs2 (BLAS xDOT)
Definition at line 454 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
DenseLinAlgPack::value_type DenseLinAlgPack::max | ( | const DVectorSlice & | vs_rhs | ) |
result = max(vs_rhs)
Definition at line 460 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
DenseLinAlgPack::value_type DenseLinAlgPack::min | ( | const DVectorSlice & | vs_rhs | ) |
result = min(vs_rhs)
Definition at line 462 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
DenseLinAlgPack::value_type DenseLinAlgPack::norm_1 | ( | const DVectorSlice & | vs_rhs | ) |
result = ||vs_rhs||1 (BLAS xASUM)
Definition at line 464 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
DenseLinAlgPack::value_type DenseLinAlgPack::norm_2 | ( | const DVectorSlice & | vs_rhs | ) |
result = ||vs_rhs||2 (BLAS xNRM2)
Definition at line 466 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
DenseLinAlgPack::value_type DenseLinAlgPack::norm_inf | ( | const DVectorSlice & | vs_rhs | ) |
result = ||vs_rhs||infinity (BLAS IxAMAX)
Definition at line 468 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
void DenseLinAlgPack::swap | ( | DVectorSlice * | vs1, |
DVectorSlice * | vs2 | ||
) |
swap(vs1, vs2). Swaps the contents of vs1 and vs2
Definition at line 482 of file DenseLinAlgPack_DVectorOpBLAS.cpp.
|
inline |
Definition at line 56 of file DenseLinAlgPack_DVectorOut.hpp.
std::ostream & DenseLinAlgPack::output | ( | std::ostream & | os, |
const DVectorSlice & | vs, | ||
LinAlgPackIO::fmtflags | extra_flags | ||
) |
Definition at line 48 of file DenseLinAlgPack_DVectorOutFunc.cpp.
|
inline |
creates an n sized vector with all zeros accepts the ith element is one.
Definition at line 50 of file DenseLinAlgPack_ElementaryMatVec.hpp.
|
inline |
creates an n x n identity matrix
Definition at line 57 of file DenseLinAlgPack_ElementaryMatVec.hpp.
std::istream & DenseLinAlgPack::operator>> | ( | std::istream & | is, |
const LinAlgPackIO::bound_format< T > & | bf | ||
) |
Definition at line 54 of file DenseLinAlgPack_InFormatDef.hpp.
void DenseLinAlgPack::update_chol_factor | ( | DMatrixSlice * | UpTriM, |
DVectorSlice * | u, | ||
const DVectorSlice & | v | ||
) |
Definition at line 61 of file DenseLinAlgPack_InvCholUpdate.cpp.
void DenseLinAlgPack::jacobi_rotate | ( | DMatrixSlice * | UpTriM, |
size_type | row_i, | ||
value_type | alpha, | ||
value_type | beta | ||
) |
Definition at line 153 of file DenseLinAlgPack_InvCholUpdate.cpp.
bool DenseLinAlgPack::comp | ( | const DVectorSlice & | vs1, |
const DVectorSlice & | vs2 | ||
) |
Definition at line 72 of file DenseLinAlgPack_MatVecCompare.cpp.
bool DenseLinAlgPack::comp | ( | const DVectorSlice & | vs, |
value_type | alpha | ||
) |
Definition at line 81 of file DenseLinAlgPack_MatVecCompare.cpp.
bool DenseLinAlgPack::comp | ( | const DMatrixSlice & | gms1, |
BLAS_Cpp::Transp | trans1, | ||
const DMatrixSlice & | gms2, | ||
BLAS_Cpp::Transp | trans2 | ||
) |
Definition at line 88 of file DenseLinAlgPack_MatVecCompare.cpp.
|
inline |
Definition at line 94 of file DenseLinAlgPack_MatVecCompare.hpp.
bool DenseLinAlgPack::comp | ( | const DMatrixSlice & | gms1, |
value_type | alpha | ||
) |
Definition at line 96 of file DenseLinAlgPack_MatVecCompare.cpp.
bool DenseLinAlgPack::comp | ( | const DMatrixSliceTriEle & | tri_gms1, |
const DMatrixSliceTriEle & | tri_gms2 | ||
) |
Definition at line 103 of file DenseLinAlgPack_MatVecCompare.cpp.
bool DenseLinAlgPack::comp | ( | const DMatrixSliceTriEle & | tri_gms1, |
value_type | alpha | ||
) |
Definition at line 118 of file DenseLinAlgPack_MatVecCompare.cpp.
bool DenseLinAlgPack::comp_less | ( | const DVectorSlice & | vs, |
value_type | alpha | ||
) |
Definition at line 132 of file DenseLinAlgPack_MatVecCompare.cpp.
std::ostream& DenseLinAlgPack::operator<< | ( | std::ostream & | os, |
const LinAlgPackIO::const_bound_format< T > & | bf | ||
) |
Definition at line 64 of file DenseLinAlgPack_OutFormat.hpp.
|
inline |
Force a type conversion from #bound_format<T># to #const_bound_format<T># to call operator<<#().
Definition at line 82 of file DenseLinAlgPack_OutFormat.hpp.
std::istream & DenseLinAlgPack::operator>> | ( | std::istream & | istrm, |
IVector & | perm | ||
) |
Definition at line 45 of file DenseLinAlgPack_PermIn.cpp.
std::ostream & DenseLinAlgPack::operator<< | ( | std::ostream & | o, |
const IVector & | perm | ||
) |
Definition at line 47 of file DenseLinAlgPack_PermOut.cpp.
void DenseLinAlgPack::identity_perm | ( | IVector * | perm | ) |
Definition at line 65 of file DenseLinAlgPack_PermVecMat.cpp.
void DenseLinAlgPack::inv_perm | ( | const IVector & | perm, |
IVector * | inv_perm | ||
) |
Definition at line 73 of file DenseLinAlgPack_PermVecMat.cpp.
void DenseLinAlgPack::perm_ele | ( | const IVector & | perm, |
DVectorSlice * | vs | ||
) |
Permute a DVectorSlice in place.
Definition at line 79 of file DenseLinAlgPack_PermVecMat.cpp.
void DenseLinAlgPack::perm_ele | ( | const DVectorSlice & | x, |
const IVector & | perm, | ||
DVectorSlice * | y | ||
) |
Perform y = P*x.
Definition at line 94 of file DenseLinAlgPack_PermVecMat.cpp.
void DenseLinAlgPack::inv_perm_ele | ( | const DVectorSlice & | y, |
const IVector & | perm, | ||
DVectorSlice * | x | ||
) |
Perform x = P'*y.
Definition at line 108 of file DenseLinAlgPack_PermVecMat.cpp.
void DenseLinAlgPack::perm_rows | ( | const IVector & | row_perm, |
DMatrixSlice * | gms | ||
) |
Permute a GenMatrixSlices rows.
Definition at line 140 of file DenseLinAlgPack_PermVecMat.cpp.
void DenseLinAlgPack::perm_cols | ( | const IVector & | col_perm, |
DMatrixSlice * | gms | ||
) |
Permute a GenMatrixSlices columns.
Definition at line 152 of file DenseLinAlgPack_PermVecMat.cpp.
void DenseLinAlgPack::perm_rows_cols | ( | const IVector & | row_perm, |
const IVector & | col_perm, | ||
DMatrixSlice * | gms | ||
) |
Permute a GenMatrixSlices rows and columns.
Definition at line 164 of file DenseLinAlgPack_PermVecMat.cpp.
void DenseLinAlgPack::seed_random_vector_generator | ( | unsigned int | s | ) |
Definition at line 49 of file DenseLinAlgPack_random_vector.cpp.
void DenseLinAlgPack::random_vector | ( | value_type | l, |
value_type | u, | ||
DVectorSlice * | v | ||
) |
Definition at line 54 of file DenseLinAlgPack_random_vector.cpp.
const value_type DenseLinAlgPack::sqrt_eps = ::sqrt(std::numeric_limits<value_type>::epsilon()) |
Definition at line 76 of file DenseLinAlgPack_MatVecCompare.hpp.