Compadre  1.5.5
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Pages
Namespaces | Functions
Compadre_Basis.hpp File Reference
#include "Compadre_GMLS.hpp"

Go to the source code of this file.

Namespaces

 Compadre
 

Functions

template<typename BasisData >
KOKKOS_INLINE_FUNCTION void Compadre::calcPij (const BasisData &data, const member_type &teamMember, double *delta, double *thread_workspace, const int target_index, int neighbor_index, const double alpha, const int dimension, const int poly_order, bool specific_order_only=false, const scratch_matrix_right_type *V=NULL, const ReconstructionSpace reconstruction_space=ReconstructionSpace::ScalarTaylorPolynomial, const SamplingFunctional polynomial_sampling_functional=PointSample, const int evaluation_site_local_index=0)
 Evaluates the polynomial basis under a particular sampling function. Generally used to fill a row of P. More...
 
template<typename BasisData >
KOKKOS_INLINE_FUNCTION void Compadre::calcGradientPij (const BasisData &data, const member_type &teamMember, double *delta, double *thread_workspace, const int target_index, int neighbor_index, const double alpha, const int partial_direction, const int dimension, const int poly_order, bool specific_order_only, const scratch_matrix_right_type *V, const ReconstructionSpace reconstruction_space, const SamplingFunctional polynomial_sampling_functional, const int evaluation_site_local_index=0)
 Evaluates the gradient of a polynomial basis under the Dirac Delta (pointwise) sampling function. More...
 
template<typename BasisData >
KOKKOS_INLINE_FUNCTION void Compadre::calcHessianPij (const BasisData &data, const member_type &teamMember, double *delta, double *thread_workspace, const int target_index, int neighbor_index, const double alpha, const int partial_direction_1, const int partial_direction_2, const int dimension, const int poly_order, bool specific_order_only, const scratch_matrix_right_type *V, const ReconstructionSpace reconstruction_space, const SamplingFunctional polynomial_sampling_functional, const int evaluation_site_local_index=0)
 Evaluates the Hessian of a polynomial basis under the Dirac Delta (pointwise) sampling function. More...
 
template<typename BasisData >
KOKKOS_INLINE_FUNCTION void Compadre::createWeightsAndP (const BasisData &data, const member_type &teamMember, scratch_vector_type delta, scratch_vector_type thread_workspace, scratch_matrix_right_type P, scratch_vector_type w, const int dimension, int polynomial_order, bool weight_p=false, scratch_matrix_right_type *V=NULL, const ReconstructionSpace reconstruction_space=ReconstructionSpace::ScalarTaylorPolynomial, const SamplingFunctional polynomial_sampling_functional=PointSample)
 Fills the _P matrix with either P or P*sqrt(w) More...
 
template<typename BasisData >
KOKKOS_INLINE_FUNCTION void Compadre::createWeightsAndPForCurvature (const BasisData &data, const member_type &teamMember, scratch_vector_type delta, scratch_vector_type thread_workspace, scratch_matrix_right_type P, scratch_vector_type w, const int dimension, bool only_specific_order, scratch_matrix_right_type *V=NULL)
 Fills the _P matrix with P*sqrt(w) for use in solving for curvature. More...