Sacado Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Classes | Functions
view/TestAssembly.hpp File Reference
#include <iostream>
#include "Teuchos_TestingHelpers.hpp"
#include "Teuchos_VerboseObject.hpp"
#include <BoxElemFixture.hpp>
#include <fenl_functors.hpp>
Include dependency graph for view/TestAssembly.hpp:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Classes

struct  Perf
 

Functions

template<typename Scalar , typename Device , Kokkos::Example::BoxElemPart::ElemOrder Order, Kokkos::Example::FENL::AssemblyMethod Method>
Perf fenl_assembly (const int use_print, const int use_trials, const int use_nodes[], Kokkos::View< Scalar *, Device > &residual, Kokkos::Example::FENL::CrsMatrix< Scalar, Device > &jacobian)
 
template<class ValueType >
bool compareValues (const ValueType &a1, const std::string &a1_name, const ValueType &a2, const std::string &a2_name, const ValueType &rel_tol, const ValueType &abs_tol, Teuchos::FancyOStream &out)
 
template<typename VectorType , typename MatrixType >
bool check_assembly (const VectorType &analytic_residual, const MatrixType &analytic_jacobian, const VectorType &fad_residual, const MatrixType &fad_jacobian, const std::string &test_name)
 
template<class Device >
void performance_test_driver (const int use_print, const int use_trials, const int n_begin, const int n_end, const int n_step, const bool quadratic, const bool check)
 

Function Documentation

template<typename Scalar , typename Device , Kokkos::Example::BoxElemPart::ElemOrder Order, Kokkos::Example::FENL::AssemblyMethod Method>
Perf fenl_assembly ( const int  use_print,
const int  use_trials,
const int  use_nodes[],
Kokkos::View< Scalar *, Device > &  residual,
Kokkos::Example::FENL::CrsMatrix< Scalar, Device > &  jacobian 
)

Definition at line 74 of file view/TestAssembly.hpp.

template<class ValueType >
bool compareValues ( const ValueType &  a1,
const std::string &  a1_name,
const ValueType &  a2,
const std::string &  a2_name,
const ValueType &  rel_tol,
const ValueType &  abs_tol,
Teuchos::FancyOStream out 
)

Definition at line 172 of file view/TestAssembly.hpp.

template<typename VectorType , typename MatrixType >
bool check_assembly ( const VectorType &  analytic_residual,
const MatrixType &  analytic_jacobian,
const VectorType &  fad_residual,
const MatrixType &  fad_jacobian,
const std::string &  test_name 
)

Definition at line 194 of file view/TestAssembly.hpp.

template<class Device >
void performance_test_driver ( const int  use_print,
const int  use_trials,
const int  n_begin,
const int  n_end,
const int  n_step,
const bool  quadratic,
const bool  check 
)

Definition at line 264 of file view/TestAssembly.hpp.