Reference documentation for deal.II version GIT relicensing-220-g40aaea9664 2024-03-28 18:00: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 | Public Member Functions | Static Public Member Functions | Public Attributes | List of all members
internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number > Struct Template Reference

#include <deal.II/matrix_free/mapping_info_storage.h>

Inheritance diagram for internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >:
Inheritance graph
[legend]

Classes

struct  QuadratureDescriptor
 

Public Member Functions

void clear_data_fields ()
 
unsigned int quad_index_from_n_q_points (const unsigned int n_q_points) const
 
template<typename StreamType >
void print_memory_consumption (StreamType &out, const TaskInfo &task_info) const
 
std::size_t memory_consumption () const
 

Static Public Member Functions

static UpdateFlags compute_update_flags (const UpdateFlags update_flags, const std::vector<::hp::QCollection< spacedim > > &quads=std::vector<::hp::QCollection< spacedim > >(), const bool piola_transform=false)
 

Public Attributes

std::vector< QuadratureDescriptordescriptor
 
std::vector<::hp::QCollection< structdim > > q_collection
 
AlignedVector< unsigned intdata_index_offsets
 
AlignedVector< Number > JxW_values
 
AlignedVector< Tensor< 1, spacedim, Number > > normal_vectors
 
std::array< AlignedVector< Tensor< 2, spacedim, Number > >, 2 > jacobians
 
std::array< AlignedVector< Tensor< 1, spacedim *(spacedim+1)/2, Tensor< 1, spacedim, Number > > >, 2 > jacobian_gradients
 
std::array< AlignedVector< Tensor< 1, spacedim *(spacedim+1)/2, Tensor< 1, spacedim, Number > > >, 2 > jacobian_gradients_non_inverse
 
std::array< AlignedVector< Tensor< 1, spacedim, Number > >, 2 > normals_times_jacobians
 
AlignedVector< unsigned intquadrature_point_offsets
 
AlignedVector< Point< spacedim, Number > > quadrature_points
 

Detailed Description

template<int structdim, int spacedim, typename Number>
struct internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >

Definition of a structure that stores all cached data related to the evaluated geometry from the mapping. In order to support hp-adaptivity and compressed storage (in particular for Jacobians, JxW values, and normals), storage length can be different for different rows. Thus, it allows to jump at the data of individual rows similar to compressed row storage in sparse matrices. We have two different start indices for fields with different sizes. The first category of offsets are the indices for Jacobians of the transformation from unit to real cell (we store the inverse Jacobian), second derivatives, JxW values, and normal vectors. We keep separate arrays for all these data structures because a user code might access only some of them. In such a case, one array will be gone through in a contiguous order with access to all entries, which makes it easy for the processor to prefetch data. Having all data in a single array would require some strides in the access pattern, which is much more complicated for the processor to predict (and indeed leads to prefetching of data that does not get used on Intel processors such as BroadwellEP).

The second category of indices are the offsets for the quadrature points. Quadrature points can be compressed less than the other fields and thus need longer fields. Quadrature point indices are often used in other contexts such as evaluation of right hand sides.

The third component is a descriptor of data from the unit cells, called QuadratureDescriptor, which contains the quadrature weights and permutations of how to go through quadrature points in case of face data. The latter comes in a vector for the support of hp-adaptivity, with several data fields for the individual quadrature formulas.

Definition at line 112 of file mapping_info_storage.h.

Member Function Documentation

◆ clear_data_fields()

template<int structdim, int spacedim, typename Number >
void internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::clear_data_fields ( )

Clears all data fields except the descriptor vector.

◆ quad_index_from_n_q_points()

template<int structdim, int spacedim, typename Number >
unsigned int internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::quad_index_from_n_q_points ( const unsigned int  n_q_points) const
inline

Returns the quadrature index for a given number of quadrature points. If not in hp-mode or if the index is not found, this function always returns index 0. Hence, this function does not check whether the given degree is actually present.

Definition at line 357 of file mapping_info_storage.h.

◆ compute_update_flags()

template<int structdim, int spacedim, typename Number >
static UpdateFlags internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::compute_update_flags ( const UpdateFlags  update_flags,
const std::vector<::hp::QCollection< spacedim > > &  quads = std::vector<::hp::QCollection< spacedim > >(),
const bool  piola_transform = false 
)
static

Helper function to determine which update flags must be set in the internal functions to initialize all data as requested by the user.

◆ print_memory_consumption()

template<int structdim, int spacedim, typename Number >
template<typename StreamType >
void internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::print_memory_consumption ( StreamType &  out,
const TaskInfo task_info 
) const

Prints a detailed summary of memory consumption in the different structures of this class to the given output stream.

◆ memory_consumption()

template<int structdim, int spacedim, typename Number >
std::size_t internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::memory_consumption ( ) const

Returns the memory consumption in bytes.

Member Data Documentation

◆ descriptor

template<int structdim, int spacedim, typename Number >
std::vector<QuadratureDescriptor> internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::descriptor

A class describing the layout of the sections in the data_storage field and also includes some data that depends on the number of quadrature points in the hp-context such as the inner quadrature formula and re-indexing for faces that are not in the standard orientation.

Definition at line 185 of file mapping_info_storage.h.

◆ q_collection

template<int structdim, int spacedim, typename Number >
std::vector<::hp::QCollection<structdim> > internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::q_collection

Collection of quadrature formulae applied on the given face.

Note
Only filled for faces, since faces might be quadrilateral or triangle shaped.

Definition at line 193 of file mapping_info_storage.h.

◆ data_index_offsets

template<int structdim, int spacedim, typename Number >
AlignedVector<unsigned int> internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::data_index_offsets

Stores the index offset into the arrays jxw_values, jacobians, normal_vectors and the second derivatives. Note that affine cells have shorter fields of length 1, where the others have lengths equal to the number of quadrature points of the given cell.

Definition at line 201 of file mapping_info_storage.h.

◆ JxW_values

template<int structdim, int spacedim, typename Number >
AlignedVector<Number> internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::JxW_values

The storage of the Jacobian determinant (times the quadrature weight in case the transformation is non-affine) on quadrature points.

Indexed by data_index_offsets.

Definition at line 210 of file mapping_info_storage.h.

◆ normal_vectors

template<int structdim, int spacedim, typename Number >
AlignedVector<Tensor<1, spacedim, Number> > internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::normal_vectors

Stores the normal vectors.

Indexed by data_index_offsets.

Definition at line 217 of file mapping_info_storage.h.

◆ jacobians

template<int structdim, int spacedim, typename Number >
std::array<AlignedVector<Tensor<2, spacedim, Number> >, 2> internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::jacobians

The storage of covariant transformation on quadrature points, i.e., the inverse and transposed Jacobians of the transformation from the unit to the real cell.

Indexed by data_index_offsets.

Contains two fields for access from both sides for interior faces, but the default case (cell integrals or boundary integrals) only fills the zeroth component and ignores the first one.

If the cell is Cartesian/affine then the Jacobian is stored at index 1 of the AlignedVector. For faces on hypercube elements, the derivatives are reorder s.t the derivative orthogonal to the face is stored last, i.e for dim = 3 and face_no = 0 or 1, the derivatives are ordered as [dy, dz, dx], face_no = 2 or 3: [dz, dx, dy], and face_no = 5 or 6: [dx, dy, dz]. If the Jacobian also is stored, the components are instead reordered in the same way.

Definition at line 238 of file mapping_info_storage.h.

◆ jacobian_gradients

template<int structdim, int spacedim, typename Number >
std::array< AlignedVector< Tensor<1, spacedim *(spacedim + 1) / 2, Tensor<1, spacedim, Number> > >, 2> internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::jacobian_gradients

The storage of the gradients of the inverse Jacobian transformation. Because of symmetry, only the upper diagonal and diagonal part are needed. The first index runs through the derivatives, starting with the diagonal and then continuing row-wise, i.e., \(\partial^2/\partial x_1 \partial x_2\) first, then \(\partial^2/\partial x_1 \partial x_3\), and so on. The second index is the spatial coordinate.

Indexed by data_index_offsets.

Contains two fields for access from both sides for interior faces, but the default case (cell integrals or boundary integrals) only fills the zeroth component and ignores the first one.

Definition at line 259 of file mapping_info_storage.h.

◆ jacobian_gradients_non_inverse

template<int structdim, int spacedim, typename Number >
std::array< AlignedVector< Tensor<1, spacedim *(spacedim + 1) / 2, Tensor<1, spacedim, Number> > >, 2> internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::jacobian_gradients_non_inverse

The storage of the gradients of the Jacobian transformation. Because of symmetry, only the upper diagonal and diagonal part are needed. The first index runs through the derivatives, starting with the diagonal and then continuing row-wise, i.e., \(\partial^2/\partial x_1 \partial x_2\) first, then \(\partial^2/\partial x_1 \partial x_3\), and so on. The second index is the spatial coordinate.

Indexed by data_index_offsets.

Contains two fields for access from both sides for interior faces, but the default case (cell integrals or boundary integrals) only fills the zeroth component and ignores the first one.

Definition at line 280 of file mapping_info_storage.h.

◆ normals_times_jacobians

template<int structdim, int spacedim, typename Number >
std::array<AlignedVector<Tensor<1, spacedim, Number> >, 2> internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::normals_times_jacobians

Stores the Jacobian transformations times the normal vector (this represents a shortcut that is accessed often and can thus get higher performance).

Indexed by data_index_offsets.

Definition at line 290 of file mapping_info_storage.h.

◆ quadrature_point_offsets

template<int structdim, int spacedim, typename Number >
AlignedVector<unsigned int> internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::quadrature_point_offsets

Stores the index offset of a particular cell into the quadrature points array in real coordinates. Note that Cartesian cells have shorter fields (length is n_q_points_1d) than non-Cartesian cells (length is n_q_points) or faces.

Definition at line 298 of file mapping_info_storage.h.

◆ quadrature_points

template<int structdim, int spacedim, typename Number >
AlignedVector<Point<spacedim, Number> > internal::MatrixFreeFunctions::MappingInfoStorage< structdim, spacedim, Number >::quadrature_points

Stores the quadrature points in real coordinates, including a compression scheme for Cartesian cells where we do not need to store the full data on all points.

Indexed by quadrature_point_offsets.

Definition at line 307 of file mapping_info_storage.h.


The documentation for this struct was generated from the following file: