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
vector_tools_constraints.h
Go to the documentation of this file.
1// ---------------------------------------------------------------------
2//
3// Copyright (C) 1998 - 2022 by the deal.II authors
4//
5// This file is part of the deal.II library.
6//
7// The deal.II library is free software; you can use it, redistribute
8// it, and/or modify it under the terms of the GNU Lesser General
9// Public License as published by the Free Software Foundation; either
10// version 2.1 of the License, or (at your option) any later version.
11// The full text of the license can be found in the file LICENSE.md at
12// the top level directory of deal.II.
13//
14// ---------------------------------------------------------------------
15
16
17#ifndef dealii_vector_tools_constraints_h
18#define dealii_vector_tools_constraints_h
19
20#include <deal.II/base/config.h>
21
23
25
26#include <map>
27#include <set>
28
30
31template <typename number>
33template <int dim, int spacedim>
34struct StaticMappingQ1;
35template <int dim, typename Number>
36class Function;
37template <int dim, int spacedim>
38class Mapping;
39
40
41namespace VectorTools
42{
278 template <int dim, int spacedim>
279 void
281 const DoFHandler<dim, spacedim> & dof_handler,
282 const unsigned int first_vector_component,
283 const std::set<types::boundary_id> &boundary_ids,
284 const std::map<types::boundary_id, const Function<spacedim, double> *>
285 & function_map,
286 AffineConstraints<double> & constraints,
287 const Mapping<dim, spacedim> &mapping =
288 (ReferenceCells::get_hypercube<dim>()
289#ifndef _MSC_VER
290 .template get_default_linear_mapping<dim, spacedim>()
291#else
292 .ReferenceCell::get_default_linear_mapping<dim, spacedim>()
293#endif
294 ));
295
305 template <int dim, int spacedim>
306 void
308 const DoFHandler<dim, spacedim> & dof_handler,
309 const unsigned int first_vector_component,
310 const std::set<types::boundary_id> &boundary_ids,
311 const std::map<types::boundary_id, const Function<spacedim, double> *>
312 & function_map,
313 AffineConstraints<double> & constraints,
314 const Mapping<dim, spacedim> &mapping =
315 (ReferenceCells::get_hypercube<dim>()
316#ifndef _MSC_VER
317 .template get_default_linear_mapping<dim, spacedim>()
318#else
319 .ReferenceCell::get_default_linear_mapping<dim, spacedim>()
320#endif
321 ),
322 const IndexSet & refinement_edge_indices = IndexSet(),
323 const unsigned int level = numbers::invalid_unsigned_int);
324
340 template <int dim, int spacedim>
341 void
343 const DoFHandler<dim, spacedim> & dof_handler,
344 const unsigned int first_vector_component,
345 const std::set<types::boundary_id> &boundary_ids,
346 AffineConstraints<double> & constraints,
347 const Mapping<dim, spacedim> & mapping =
348 (ReferenceCells::get_hypercube<dim>()
349#ifndef _MSC_VER
350 .template get_default_linear_mapping<dim, spacedim>()
351#else
352 .ReferenceCell::get_default_linear_mapping<dim, spacedim>()
353#endif
354 ));
355
365 template <int dim, int spacedim>
366 void
368 const DoFHandler<dim, spacedim> & dof_handler,
369 const unsigned int first_vector_component,
370 const std::set<types::boundary_id> &boundary_ids,
371 AffineConstraints<double> & constraints,
372 const Mapping<dim, spacedim> & mapping =
373 (ReferenceCells::get_hypercube<dim>()
374#ifndef _MSC_VER
375 .template get_default_linear_mapping<dim, spacedim>()
376#else
377 .ReferenceCell::get_default_linear_mapping<dim, spacedim>()
378#endif
379 ),
380 const IndexSet & refinement_edge_indices = IndexSet(),
381 const unsigned int level = numbers::invalid_unsigned_int);
382
399 template <int dim, int spacedim>
400 void
402 const DoFHandler<dim, spacedim> & dof_handler,
403 const unsigned int first_vector_component,
404 const std::set<types::boundary_id> &boundary_ids,
405 const std::map<types::boundary_id, const Function<spacedim, double> *>
406 & function_map,
407 AffineConstraints<double> & constraints,
408 const Mapping<dim, spacedim> &mapping =
409 (ReferenceCells::get_hypercube<dim>()
410#ifndef _MSC_VER
411 .template get_default_linear_mapping<dim, spacedim>()
412#else
413 .ReferenceCell::get_default_linear_mapping<dim, spacedim>()
414#endif
415 ));
416
425 template <int dim, int spacedim>
426 void
428 const DoFHandler<dim, spacedim> & dof_handler,
429 const unsigned int first_vector_component,
430 const std::set<types::boundary_id> &boundary_ids,
431 AffineConstraints<double> & constraints,
432 const Mapping<dim, spacedim> & mapping =
433 (ReferenceCells::get_hypercube<dim>()
434#ifndef _MSC_VER
435 .template get_default_linear_mapping<dim, spacedim>()
436#else
437 .ReferenceCell::get_default_linear_mapping<dim, spacedim>()
438#endif
439 ));
440
442} // namespace VectorTools
443
445
446#endif // dealii_vector_tools_constraints_h
Abstract base class for mapping classes.
Definition mapping.h:317
#define DEAL_II_NAMESPACE_OPEN
Definition config.h:472
#define DEAL_II_NAMESPACE_CLOSE
Definition config.h:473
unsigned int level
Definition grid_out.cc:4618
void compute_no_normal_flux_constraints_on_level(const DoFHandler< dim, spacedim > &dof_handler, const unsigned int first_vector_component, const std::set< types::boundary_id > &boundary_ids, AffineConstraints< double > &constraints, const Mapping< dim, spacedim > &mapping=(ReferenceCells::get_hypercube< dim >() .template get_default_linear_mapping< dim, spacedim >()), const IndexSet &refinement_edge_indices=IndexSet(), const unsigned int level=numbers::invalid_unsigned_int)
void compute_no_normal_flux_constraints(const DoFHandler< dim, spacedim > &dof_handler, const unsigned int first_vector_component, const std::set< types::boundary_id > &boundary_ids, AffineConstraints< double > &constraints, const Mapping< dim, spacedim > &mapping=(ReferenceCells::get_hypercube< dim >() .template get_default_linear_mapping< dim, spacedim >()))
void compute_nonzero_normal_flux_constraints_on_level(const DoFHandler< dim, spacedim > &dof_handler, const unsigned int first_vector_component, const std::set< types::boundary_id > &boundary_ids, const std::map< types::boundary_id, const Function< spacedim, double > * > &function_map, AffineConstraints< double > &constraints, const Mapping< dim, spacedim > &mapping=(ReferenceCells::get_hypercube< dim >() .template get_default_linear_mapping< dim, spacedim >()), const IndexSet &refinement_edge_indices=IndexSet(), const unsigned int level=numbers::invalid_unsigned_int)
void compute_normal_flux_constraints(const DoFHandler< dim, spacedim > &dof_handler, const unsigned int first_vector_component, const std::set< types::boundary_id > &boundary_ids, AffineConstraints< double > &constraints, const Mapping< dim, spacedim > &mapping=(ReferenceCells::get_hypercube< dim >() .template get_default_linear_mapping< dim, spacedim >()))
void compute_nonzero_normal_flux_constraints(const DoFHandler< dim, spacedim > &dof_handler, const unsigned int first_vector_component, const std::set< types::boundary_id > &boundary_ids, const std::map< types::boundary_id, const Function< spacedim, double > * > &function_map, AffineConstraints< double > &constraints, const Mapping< dim, spacedim > &mapping=(ReferenceCells::get_hypercube< dim >() .template get_default_linear_mapping< dim, spacedim >()))
void compute_nonzero_tangential_flux_constraints(const DoFHandler< dim, spacedim > &dof_handler, const unsigned int first_vector_component, const std::set< types::boundary_id > &boundary_ids, const std::map< types::boundary_id, const Function< spacedim, double > * > &function_map, AffineConstraints< double > &constraints, const Mapping< dim, spacedim > &mapping=(ReferenceCells::get_hypercube< dim >() .template get_default_linear_mapping< dim, spacedim >()))
static const unsigned int invalid_unsigned_int
Definition types.h:213