1 #ifndef _COMPADRE_LINEAR_ALGEBRA_DECLARATIONS_HPP_ 2 #define _COMPADRE_LINEAR_ALGEBRA_DECLARATIONS_HPP_ 4 #include "Compadre_Config.h" 10 namespace GMLS_LinearAlgebra {
18 KOKKOS_INLINE_FUNCTION
46 template <
typename A_layout=layout_right,
typename B_layout=layout_right,
typename X_layout=layout_right>
47 void batchQRPivotingSolve(ParallelManager pm,
double *A,
int lda,
int nda,
double *B,
int ldb,
int ndb,
int M,
int N,
int NRHS,
const int num_matrices);
team_policy::member_type member_type
KOKKOS_INLINE_FUNCTION void largestTwoEigenvectorsThreeByThreeSymmetric(const member_type &teamMember, scratch_matrix_right_type V, scratch_matrix_right_type PtP, const int dimensions, pool_type &random_number_pool)
Calculates two eigenvectors corresponding to two dominant eigenvalues.
Kokkos::View< double **, layout_right, Kokkos::MemoryTraits< Kokkos::Unmanaged > > scratch_matrix_right_type
void batchQRPivotingSolve(ParallelManager pm, double *A, int lda, int nda, double *B, int ldb, int ndb, int M, int N, int NRHS, const int num_matrices)
Solves a batch of problems with QR+Pivoting.
Kokkos::Random_XorShift64_Pool pool_type