1 #ifndef _COMPADRE_MISC_HPP_
2 #define _COMPADRE_MISC_HPP_
10 KOKKOS_INLINE_FUNCTION
13 KOKKOS_INLINE_FUNCTION
14 XYZ(
double _x,
double _y,
double _z) :
x(_x),
y(_y),
z(_z) {}
20 KOKKOS_INLINE_FUNCTION
32 KOKKOS_INLINE_FUNCTION
42 KOKKOS_INLINE_FUNCTION
52 KOKKOS_INLINE_FUNCTION
57 return dimension*added_alpha_size;
59 return added_alpha_size;
63 KOKKOS_INLINE_FUNCTION
72 return N + added_coeff_size;
74 if (dense_solver_type !=
LU) {
77 return N + added_coeff_size;
82 KOKKOS_INLINE_FUNCTION
92 out_row = M + added_alpha_size;
93 out_col = N + added_coeff_size;
95 if (dense_solver_type ==
LU) {
96 out_row = M + added_alpha_size;
97 out_col = N + added_coeff_size;
KOKKOS_INLINE_FUNCTION int getAdditionalAlphaSizeFromConstraint(DenseSolverType dense_solver_type, ConstraintType constraint_type)
KOKKOS_INLINE_FUNCTION int getAdditionalCoeffSizeFromConstraintAndSpace(DenseSolverType dense_solver_type, ConstraintType constraint_type, ReconstructionSpace reconstruction_space, const int dimension)
Neumann Gradient Scalar Type.
KOKKOS_INLINE_FUNCTION XYZ operator*(double scalar)
KOKKOS_INLINE_FUNCTION double & operator[](const int i)
ReconstructionSpace
Space in which to reconstruct polynomial.
KOKKOS_INLINE_FUNCTION XYZ(double _x, double _y, double _z)
KOKKOS_INLINE_FUNCTION void getPDims(DenseSolverType dense_solver_type, ConstraintType constraint_type, ReconstructionSpace reconstruction_space, const int dimension, const int M, const int N, int &out_row, int &out_col)
DenseSolverType
Dense solver type.
LU factorization performed on P^T*W*P matrix.
KOKKOS_INLINE_FUNCTION int getRHSSquareDim(DenseSolverType dense_solver_type, ConstraintType constraint_type, ReconstructionSpace reconstruction_space, const int dimension, const int M, const int N)
KOKKOS_INLINE_FUNCTION XYZ()
Vector polynomial basis having # of components _dimensions, or (_dimensions-1) in the case of manifol...
ConstraintType
Constraint type.