Reference documentation for deal.II version 9.5.0
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Loading...
Searching...
No Matches
Namespaces | Enumerations | Functions
vector_tools_evaluate.h File Reference
#include <deal.II/base/config.h>
#include <deal.II/base/mpi_remote_point_evaluation.h>
#include <deal.II/distributed/tria_base.h>
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/la_parallel_vector.h>
#include <deal.II/lac/vector.h>
#include <deal.II/matrix_free/fe_point_evaluation.h>

Go to the source code of this file.

Namespaces

namespace  VectorTools
 
namespace  VectorTools::EvaluationFlags
 

Enumerations

enum  VectorTools::EvaluationFlags::EvaluationFlags { VectorTools::EvaluationFlags::avg = 0 , VectorTools::EvaluationFlags::max = 1 , VectorTools::EvaluationFlags::min = 2 , VectorTools::EvaluationFlags::insert = 3 }
 

Functions

template<int n_components, template< int, int > class MeshType, int dim, int spacedim, typename VectorType >
std::vector< typename FEPointEvaluation< n_components, dim, spacedim, typename VectorType::value_type >::value_type > VectorTools::point_values (const Mapping< dim > &mapping, const MeshType< dim, spacedim > &mesh, const VectorType &vector, const std::vector< Point< spacedim > > &evaluation_points, Utilities::MPI::RemotePointEvaluation< dim, spacedim > &cache, const EvaluationFlags::EvaluationFlags flags=EvaluationFlags::avg, const unsigned int first_selected_component=0)
 
template<int n_components, template< int, int > class MeshType, int dim, int spacedim, typename VectorType >
std::vector< typename FEPointEvaluation< n_components, dim, spacedim, typename VectorType::value_type >::value_type > VectorTools::point_values (const Utilities::MPI::RemotePointEvaluation< dim, spacedim > &cache, const MeshType< dim, spacedim > &mesh, const VectorType &vector, const EvaluationFlags::EvaluationFlags flags=EvaluationFlags::avg, const unsigned int first_selected_component=0)
 
template<int n_components, template< int, int > class MeshType, int dim, int spacedim, typename VectorType >
std::vector< typename FEPointEvaluation< n_components, dim, spacedim, typename VectorType::value_type >::gradient_type > VectorTools::point_gradients (const Mapping< dim > &mapping, const MeshType< dim, spacedim > &mesh, const VectorType &vector, const std::vector< Point< spacedim > > &evaluation_points, Utilities::MPI::RemotePointEvaluation< dim, spacedim > &cache, const EvaluationFlags::EvaluationFlags flags=EvaluationFlags::avg, const unsigned int first_selected_component=0)
 
template<int n_components, template< int, int > class MeshType, int dim, int spacedim, typename VectorType >
std::vector< typename FEPointEvaluation< n_components, dim, spacedim, typename VectorType::value_type >::gradient_type > VectorTools::point_gradients (const Utilities::MPI::RemotePointEvaluation< dim, spacedim > &cache, const MeshType< dim, spacedim > &mesh, const VectorType &vector, const EvaluationFlags::EvaluationFlags flags=EvaluationFlags::avg, const unsigned int first_selected_component=0)