10 #ifndef STOKHOS_KL_ONE_D_EXPONENTIAL_COVARIANCE_FUNCTION_HPP
11 #define STOKHOS_KL_ONE_D_EXPONENTIAL_COVARIANCE_FUNCTION_HPP
86 template <
typename value_type>
134 template <
class Func>
140 template <
class Func>
180 #endif // STOKHOS_KL_ONE_D_EXPONENTIAL_COVARIANCE_FUNCTION_HPP
Teuchos::Array< eigen_pair_type > eig_pair
Eigenpairs.
KOKKOS_INLINE_FUNCTION PCE< Storage > tan(const PCE< Storage > &a)
value_type bisection(const Func &func, const value_type &a, const value_type &b, magnitude_type tol, int max_num_its)
A basic root finder based on bisection.
value_type newton(const Func &func, const value_type &a, const value_type &b, magnitude_type tol, int max_num_its)
A basic root finder based on Newton's method.
ExponentialOneDEigenFunction< value_type > eigen_function_type
Container for one-dimensional eigenfunction and eigenvalue.
value_type deriv(const value_type &u) const
OneDExponentialCovarianceFunction & operator=(const OneDExponentialCovarianceFunction &)
Prohibit copying.
OneDEigenPair< eigen_function_type > eigen_pair_type
value_type evaluateCovariance(const value_type &x, const value_type &xp) const
Evaluate covariance.
value_type eval(const value_type &u) const
OneDExponentialCovarianceFunction(int M, const value_type &a, const value_type &b, const value_type &L, const int dim_name, Teuchos::ParameterList &solverParams)
Constructor.
Nonlinear function whose roots define eigenvalues for cos() eigenfunction.
Nonlinear function whose roots define eigenvalues for sin() eigenfunction.
KOKKOS_INLINE_FUNCTION PCE< Storage > abs(const PCE< Storage > &a)
EigFuncCos(const value_type &alpha_)
Class representing an exponential covariance function and its KL eigevalues/eigenfunctions.
value_type eval(const value_type &u) const
KOKKOS_INLINE_FUNCTION PCE< Storage > exp(const PCE< Storage > &a)
EigFuncSin(const value_type &alpha_)
Teuchos::ScalarTraits< value_type >::magnitudeType magnitude_type
const Teuchos::Array< eigen_pair_type > & getEigenPairs() const
Get eigenpairs.
value_type deriv(const value_type &u) const
One-dimensional eigenfunction for exponential covariance function.
value_type L
Correlation length.
~OneDExponentialCovarianceFunction()
Destructor.
KOKKOS_INLINE_FUNCTION PCE< Storage > cos(const PCE< Storage > &a)