deal.II version GIT relicensing-3325-gccc124ab5a 2025-05-17 05:00:00+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
mapping_q_eulerian.cc
Go to the documentation of this file.
1// ------------------------------------------------------------------------
2//
3// SPDX-License-Identifier: LGPL-2.1-or-later
4// Copyright (C) 2008 - 2024 by the deal.II authors
5//
6// This file is part of the deal.II library.
7//
8// Part of the source code is dual licensed under Apache-2.0 WITH
9// LLVM-exception OR LGPL-2.1-or-later. Detailed license information
10// governing the source code and code contributions can be found in
11// LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II.
12//
13// ------------------------------------------------------------------------
14
17
20
21#include <deal.II/fe/fe.h>
22#include <deal.II/fe/fe_tools.h>
24
26
34#include <deal.II/lac/vector.h>
35
36#include <boost/container/small_vector.hpp>
37
38#include <memory>
39
40
42
43
44
45template <int dim, typename VectorType, int spacedim>
47 const unsigned int degree,
48 const DoFHandler<dim, spacedim> &euler_dof_handler,
49 const VectorType &euler_vector,
50 const unsigned int level)
51 : MappingQ<dim, spacedim>(degree)
52 , euler_vector(&euler_vector)
53 , euler_dof_handler(&euler_dof_handler)
54 , level(level)
55 , support_quadrature(degree)
56 , mapping_q(degree)
57 , fe_values(mapping_q,
58 euler_dof_handler.get_fe(),
59 support_quadrature,
61{}
62
63
64
65template <int dim, typename VectorType, int spacedim>
66std::unique_ptr<Mapping<dim, spacedim>>
68{
69 return std::make_unique<MappingQEulerian<dim, VectorType, spacedim>>(
70 this->get_degree(), *euler_dof_handler, *euler_vector, this->level);
71}
72
73
74
75template <int dim, typename VectorType, int spacedim>
77 SupportQuadrature(const unsigned int map_degree)
78 : Quadrature<dim>(Utilities::fixed_power<dim>(map_degree + 1))
79{
80 // first we determine the support points on the unit cell in lexicographic
81 // order, which are (in accordance with MappingQ) the support points of
82 // QGaussLobatto.
83 const QGaussLobatto<dim> q_iterated(map_degree + 1);
84 const unsigned int n_q_points = q_iterated.size();
85
86 // we then need to define a renumbering vector that allows us to go from a
87 // lexicographic numbering scheme to a hierarchic one.
88 const std::vector<unsigned int> renumber =
89 FETools::lexicographic_to_hierarchic_numbering<dim>(map_degree);
90
91 // finally we assign the quadrature points in the required order.
92 for (unsigned int q = 0; q < n_q_points; ++q)
93 this->quadrature_points[renumber[q]] = q_iterated.point(q);
94}
95
96
97
98template <int dim, typename VectorType, int spacedim>
99boost::container::small_vector<Point<spacedim>,
100#ifndef _MSC_VER
101 ReferenceCells::max_n_vertices<dim>()
102#else
104#endif
105 >
107 const typename Triangulation<dim, spacedim>::cell_iterator &cell) const
108{
109 // get the vertices as the first 2^dim mapping support points
110 const std::vector<Point<spacedim>> a = compute_mapping_support_points(cell);
111
112 boost::container::small_vector<Point<spacedim>,
113#ifndef _MSC_VER
114 ReferenceCells::max_n_vertices<dim>()
115#else
117#endif
118 >
119 vertex_locations(a.begin(), a.begin() + cell->n_vertices());
120
121 return vertex_locations;
122}
123
124
125
126template <int dim, typename VectorType, int spacedim>
127std::vector<Point<spacedim>>
129 const typename Triangulation<dim, spacedim>::cell_iterator &cell) const
130{
131 const bool mg_vector = level != numbers::invalid_unsigned_int;
132
133 [[maybe_unused]] const types::global_dof_index n_dofs =
134 mg_vector ? euler_dof_handler->n_dofs(level) : euler_dof_handler->n_dofs();
135 [[maybe_unused]] const types::global_dof_index vector_size =
136 euler_vector->size();
137
138 AssertDimension(vector_size, n_dofs);
139
140 // we then transform our tria iterator into a dof iterator so we can access
141 // data not associated with triangulations
142 typename DoFHandler<dim, spacedim>::cell_iterator dof_cell(*cell,
144
145 Assert(mg_vector || dof_cell->is_active() == true, ExcInactiveCell());
146
147 // our quadrature rule is chosen so that each quadrature point corresponds
148 // to a support point in the undeformed configuration. We can then query
149 // the given displacement field at these points to determine the shift
150 // vector that maps the support points to the deformed configuration.
151
152 // We assume that the given field contains dim displacement components, but
153 // that there may be other solution components as well (e.g. pressures).
154 // this class therefore assumes that the first dim components represent the
155 // actual shift vector we need, and simply ignores any components after
156 // that. This implies that the user should order components appropriately,
157 // or create a separate dof handler for the displacements.
158 const unsigned int n_support_pts = support_quadrature.size();
159 const unsigned int n_components = euler_dof_handler->get_fe(0).n_components();
160
161 Assert(n_components >= spacedim,
162 ExcDimensionMismatch(n_components, spacedim));
163
164 std::vector<Vector<typename VectorType::value_type>> shift_vector(
165 n_support_pts, Vector<typename VectorType::value_type>(n_components));
166
167 std::vector<types::global_dof_index> dof_indices(
168 euler_dof_handler->get_fe(0).n_dofs_per_cell());
169 // fill shift vector for each support point using an fe_values object. make
170 // sure that the fe_values variable isn't used simultaneously from different
171 // threads
172 std::lock_guard<std::mutex> lock(fe_values_mutex);
173 fe_values.reinit(dof_cell);
174 if (mg_vector)
175 {
176 dof_cell->get_mg_dof_indices(dof_indices);
177 fe_values.get_function_values(*euler_vector, dof_indices, shift_vector);
178 }
179 else
180 fe_values.get_function_values(*euler_vector, shift_vector);
181
182 // and finally compute the positions of the support points in the deformed
183 // configuration.
184 std::vector<Point<spacedim>> a(n_support_pts);
185 for (unsigned int q = 0; q < n_support_pts; ++q)
186 {
187 a[q] = fe_values.quadrature_point(q);
188 for (unsigned int d = 0; d < spacedim; ++d)
189 a[q][d] += shift_vector[q][d];
190 }
191
192 return a;
193}
194
195
196
197template <int dim, typename VectorType, int spacedim>
202 const Quadrature<dim> &quadrature,
203 const typename Mapping<dim, spacedim>::InternalDataBase &internal_data,
205 &output_data) const
206{
207 // call the function of the base class, but ignoring
208 // any potentially detected cell similarity between
209 // the current and the previous cell
212 quadrature,
213 internal_data,
214 output_data);
215 // also return the updated flag since any detected
216 // similarity wasn't based on the mapped field, but
217 // the original vertices which are meaningless
219}
220
221
222// explicit instantiations
223#include "fe/mapping_q_eulerian.inst"
224
225
SupportQuadrature(const unsigned int map_degree)
FEValues< dim, spacedim > fe_values
virtual std::vector< Point< spacedim > > compute_mapping_support_points(const typename Triangulation< dim, spacedim >::cell_iterator &cell) const override
virtual CellSimilarity::Similarity fill_fe_values(const typename Triangulation< dim, spacedim >::cell_iterator &cell, const CellSimilarity::Similarity cell_similarity, const Quadrature< dim > &quadrature, const typename Mapping< dim, spacedim >::InternalDataBase &internal_data, internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &output_data) const override
virtual std::unique_ptr< Mapping< dim, spacedim > > clone() const override
MappingQEulerian(const unsigned int degree, const DoFHandler< dim, spacedim > &euler_dof_handler, const VectorType &euler_vector, const unsigned int level=numbers::invalid_unsigned_int)
ObserverPointer< const VectorType, MappingQEulerian< dim, VectorType, spacedim > > euler_vector
ObserverPointer< const DoFHandler< dim, spacedim >, MappingQEulerian< dim, VectorType, spacedim > > euler_dof_handler
Threads::Mutex fe_values_mutex
const SupportQuadrature support_quadrature
virtual boost::container::small_vector< Point< spacedim >, ReferenceCells::max_n_vertices< dim >() > get_vertices(const typename Triangulation< dim, spacedim >::cell_iterator &cell) const override
const unsigned int level
virtual CellSimilarity::Similarity fill_fe_values(const typename Triangulation< dim, spacedim >::cell_iterator &cell, const CellSimilarity::Similarity cell_similarity, const Quadrature< dim > &quadrature, const typename Mapping< dim, spacedim >::InternalDataBase &internal_data, internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &output_data) const override
Definition mapping_q.cc:833
#define DEAL_II_NAMESPACE_OPEN
Definition config.h:35
#define DEAL_II_NAMESPACE_CLOSE
Definition config.h:36
unsigned int level
Definition grid_out.cc:4635
#define Assert(cond, exc)
#define AssertDimension(dim1, dim2)
static ::ExceptionBase & ExcInactiveCell()
static ::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
typename ActiveSelector::cell_iterator cell_iterator
@ update_values
Shape function values.
@ update_quadrature_points
Transformed quadrature points.
constexpr unsigned int invalid_unsigned_int
Definition types.h:238