Stokhos Package Browser (Single Doxygen Collection) Version of the Day
Loading...
Searching...
No Matches
Classes | Functions
TestAssembly.hpp File Reference
#include <iostream>
#include "Stokhos_Sacado_Kokkos_MP_Vector.hpp"
#include "Kokkos_View_MP_Vector.hpp"
#include "Sacado_mpl_range_c.hpp"
#include "Sacado_mpl_for_each.hpp"
#include "Sacado_mpl_integral_c.hpp"
#include <Kokkos_UnorderedMap.hpp>
#include <Kokkos_StaticCrsGraph.hpp>
#include <Kokkos_Timer.hpp>
#include <Teuchos_CommHelpers.hpp>
#include "Teuchos_TestingHelpers.hpp"
#include "Teuchos_VerboseObject.hpp"
#include <BoxElemFixture.hpp>
#include <VectorImport.hpp>
#include <fenl_functors.hpp>
Include dependency graph for FadMPAssembly/TestAssembly.hpp:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Classes

struct  Perf
 
struct  PerformanceDriverOp< Storage, Method >
 

Functions

double maximum (const Teuchos::RCP< const Teuchos::Comm< int > > &comm, double local)
 
template<typename Scalar , typename Device , Kokkos::Example::FENL::AssemblyMethod Method>
Perf fenl_assembly (const Teuchos::RCP< const Teuchos::Comm< int > > &comm, const int use_print, const int use_trials, const int use_nodes[], Kokkos::Example::FENL::DeviceConfig dev_config, Kokkos::View< Scalar *, Kokkos::LayoutLeft, Device > &nodal_residual)
 
template<typename ScalarViewType , typename EnsembleViewType >
bool check_residuals (const ScalarViewType &scalar_residual, const EnsembleViewType &ensemble_residual)
 
template<class Storage , int entry_min, int entry_max, int entry_step, Kokkos::Example::FENL::AssemblyMethod Method>
void performance_test_driver (const Teuchos::RCP< const Teuchos::Comm< int > > &comm, const int use_print, const int use_trials, const int use_nodes[], const bool check, Kokkos::Example::FENL::DeviceConfig dev_config)
 

Function Documentation

◆ maximum()

double maximum ( const Teuchos::RCP< const Teuchos::Comm< int > > & comm,
double local )
inline

Definition at line 92 of file FadMPAssembly/TestAssembly.hpp.

◆ fenl_assembly()

template<typename Scalar , typename Device , Kokkos::Example::FENL::AssemblyMethod Method>
Perf fenl_assembly ( const Teuchos::RCP< const Teuchos::Comm< int > > & comm,
const int use_print,
const int use_trials,
const int use_nodes[],
Kokkos::Example::FENL::DeviceConfig dev_config,
Kokkos::View< Scalar *, Kokkos::LayoutLeft, Device > & nodal_residual )

Definition at line 101 of file FadMPAssembly/TestAssembly.hpp.

◆ check_residuals()

template<typename ScalarViewType , typename EnsembleViewType >
bool check_residuals ( const ScalarViewType & scalar_residual,
const EnsembleViewType & ensemble_residual )

Definition at line 280 of file FadMPAssembly/TestAssembly.hpp.

◆ performance_test_driver()

template<class Storage , int entry_min, int entry_max, int entry_step, Kokkos::Example::FENL::AssemblyMethod Method>
void performance_test_driver ( const Teuchos::RCP< const Teuchos::Comm< int > > & comm,
const int use_print,
const int use_trials,
const int use_nodes[],
const bool check,
Kokkos::Example::FENL::DeviceConfig dev_config )

Definition at line 406 of file FadMPAssembly/TestAssembly.hpp.