Reference documentation for deal.II version GIT relicensing-487-ge9eb5ab491 2024-04-25 07:20:02+00:00
\(\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
Classes | Namespaces | Functions
fe_remote_evaluation.h File Reference
#include <deal.II/base/mpi_remote_point_evaluation.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/grid_tools_cache.h>
#include <deal.II/matrix_free/fe_evaluation.h>
#include <deal.II/matrix_free/fe_point_evaluation.h>
#include <deal.II/matrix_free/matrix_free.h>
#include <deal.II/numerics/vector_tools.h>
#include <algorithm>
#include <variant>

Go to the source code of this file.

Classes

struct  internal::PrecomputedEvaluationData< dim, n_components, value_type_ >
 
struct  internal::PrecomputedEvaluationDataView
 
class  internal::PrecomputedEvaluationDataAccessor< dim, n_components, value_type_ >
 
struct  FERemoteCommunicationObjectEntityBatches< dim >
 
struct  FERemoteCommunicationObject< dim >
 
struct  FERemoteCommunicationObjectTwoLevel< dim >
 
class  FERemoteEvaluationCommunicator< dim >
 
class  FERemoteEvaluationCommunicator< dim >::CopyInstructions
 
class  FERemoteEvaluation< dim, n_components, value_type >
 

Namespaces

namespace  internal
 
namespace  Utilities
 

Functions

template<int dim, typename Number , typename VectorizedArrayType = VectorizedArray<Number>>
FERemoteEvaluationCommunicator< dim > Utilities::compute_remote_communicator_faces_point_to_point_interpolation (const MatrixFree< dim, Number, VectorizedArrayType > &matrix_free, const std::vector< std::pair< types::boundary_id, std::function< std::vector< bool >()> > > &non_matching_faces_marked_vertices, const unsigned int quad_no=0, const unsigned int dof_no=0, const double tolerance=1e-9)
 
template<int dim, typename Number , typename VectorizedArrayType = VectorizedArray<Number>>
FERemoteEvaluationCommunicator< dim > Utilities::compute_remote_communicator_faces_nitsche_type_mortaring (const MatrixFree< dim, Number, VectorizedArrayType > &matrix_free, const std::vector< std::pair< types::boundary_id, std::function< std::vector< bool >()> > > &non_matching_faces_marked_vertices, const unsigned int n_q_pnts_1D, const unsigned int dof_no=0, NonMatching::MappingInfo< dim, dim, Number > *nm_mapping_info=nullptr, const double tolerance=1e-9)