*/
template <int dim, int spacedim>
void
- make_cell_patches(
- SparsityPattern & block_list,
- const DoFHandler<dim, spacedim> &dof_handler,
- const unsigned int level,
- const std::vector<bool> & selected_dofs = {},
- const types::global_dof_index offset = 0);
+ make_cell_patches(SparsityPattern & block_list,
+ const DoFHandler<dim, spacedim> &dof_handler,
+ const unsigned int level,
+ const std::vector<bool> & selected_dofs = {},
+ const types::global_dof_index offset = 0);
/**
* Create an incidence matrix that for every vertex on a given level of a
const DoFHandlerType & dof_handler,
std::vector<types::global_dof_index> &dofs_per_component,
const bool vector_valued_once = false,
- std::vector<unsigned int> target_component = {});
+ std::vector<unsigned int> target_component = {});
/**
* Count the degrees of freedom in each block. This function is similar to
*/
template <int dim, int spacedim>
void
- subdivided_parallelepiped(
- Triangulation<dim, spacedim> & tria,
- const Point<spacedim> & origin,
- const std::array<Tensor<1, spacedim>, dim> &edges,
- const std::vector<unsigned int> &subdivisions = {},
- const bool colorize = false);
+ subdivided_parallelepiped(Triangulation<dim, spacedim> & tria,
+ const Point<spacedim> & origin,
+ const std::array<Tensor<1, spacedim>, dim> &edges,
+ const std::vector<unsigned int> &subdivisions = {},
+ const bool colorize = false);
/**
* Hypercube with a layer of hypercubes around it. The first two parameters
*/
template <int dim, template <int, int> class MeshType, int spacedim>
unsigned int
- find_closest_vertex(
- const MeshType<dim, spacedim> &mesh,
- const Point<spacedim> & p,
- const std::vector<bool> & marked_vertices = {});
+ find_closest_vertex(const MeshType<dim, spacedim> &mesh,
+ const Point<spacedim> & p,
+ const std::vector<bool> & marked_vertices = {});
/**
* Find and return the index of the used vertex (or marked vertex) in a
*/
template <int dim, template <int, int> class MeshType, int spacedim>
unsigned int
- find_closest_vertex(
- const Mapping<dim, spacedim> & mapping,
- const MeshType<dim, spacedim> &mesh,
- const Point<spacedim> & p,
- const std::vector<bool> & marked_vertices = {});
+ find_closest_vertex(const Mapping<dim, spacedim> & mapping,
+ const MeshType<dim, spacedim> &mesh,
+ const Point<spacedim> & p,
+ const std::vector<bool> & marked_vertices = {});
/**
# ifndef _MSC_VER
typename MeshType<dim, spacedim>::active_cell_iterator
# else
- typename dealii::internal::
- ActiveCellIterator<dim, spacedim, MeshType<dim, spacedim>>::type
+ typename dealii::internal::ActiveCellIterator<dim,
+ spacedim,
+ MeshType<dim, spacedim>>::type
# endif
- find_active_cell_around_point(
- const MeshType<dim, spacedim> &mesh,
- const Point<spacedim> & p,
- const std::vector<bool> & marked_vertices = {});
+ find_active_cell_around_point(const MeshType<dim, spacedim> &mesh,
+ const Point<spacedim> & p,
+ const std::vector<bool> &marked_vertices = {});
/**
* Find and return an iterator to the active cell that surrounds a given
ActiveCellIterator<dim, spacedim, MeshType<dim, spacedim>>::type,
Point<dim>>
# endif
- find_active_cell_around_point(
- const Mapping<dim, spacedim> & mapping,
- const MeshType<dim, spacedim> &mesh,
- const Point<spacedim> & p,
- const std::vector<bool> & marked_vertices = {});
+ find_active_cell_around_point(const Mapping<dim, spacedim> & mapping,
+ const MeshType<dim, spacedim> &mesh,
+ const Point<spacedim> & p,
+ const std::vector<bool> &marked_vertices = {});
/**
* A version of the previous function that exploits an already existing
count_dofs_per_block(
const DoFHandlerType & dof_handler,
std::vector<std::vector<types::global_dof_index>> &dofs_per_block,
- std::vector<unsigned int> target_block = {});
+ std::vector<unsigned int> target_block = {});
/**
* Count the dofs component-wise on each level.
count_dofs_per_component(
const DoFHandler<dim, spacedim> & mg_dof,
std::vector<std::vector<types::global_dof_index>> &result,
- const bool only_once = false,
- std::vector<unsigned int> target_component = {});
+ const bool only_once = false,
+ std::vector<unsigned int> target_component = {});
/**
* Generate a list of those degrees of freedom at the boundary of the domain
& boundary_functions,
Vector<number> & rhs_vector,
std::vector<types::global_dof_index> & dof_to_boundary_mapping,
- const Function<spacedim, number> *const weight = 0,
- std::vector<unsigned int> component_mapping = {});
+ const Function<spacedim, number> *const weight = 0,
+ std::vector<unsigned int> component_mapping = {});
/**
& boundary_functions,
Vector<number> & rhs_vector,
std::vector<types::global_dof_index> & dof_to_boundary_mapping,
- const Function<spacedim, number> *const a = nullptr,
- std::vector<unsigned int> component_mapping = {});
+ const Function<spacedim, number> *const a = nullptr,
+ std::vector<unsigned int> component_mapping = {});
/**
* Same function as above, but for hp objects.
& boundary_functions,
Vector<number> & rhs_vector,
std::vector<types::global_dof_index> & dof_to_boundary_mapping,
- const Function<spacedim, number> *const a = nullptr,
- std::vector<unsigned int> component_mapping = {});
+ const Function<spacedim, number> *const a = nullptr,
+ std::vector<unsigned int> component_mapping = {});
/**
* Same function as above, but for hp objects.
& boundary_functions,
Vector<number> & rhs_vector,
std::vector<types::global_dof_index> & dof_to_boundary_mapping,
- const Function<spacedim, number> *const a = nullptr,
- std::vector<unsigned int> component_mapping = {});
+ const Function<spacedim, number> *const a = nullptr,
+ std::vector<unsigned int> component_mapping = {});
/**
* Assemble the Laplace matrix. If no coefficient is given (i.e., if the
& boundary_functions,
const Quadrature<dim - 1> & q,
std::map<types::global_dof_index, number> &boundary_values,
- std::vector<unsigned int> component_mapping = {});
+ std::vector<unsigned int> component_mapping = {});
/**
* Call the project_boundary_values() function, see above, with
& boundary_function,
const Quadrature<dim - 1> & q,
std::map<types::global_dof_index, number> &boundary_values,
- std::vector<unsigned int> component_mapping = {});
+ std::vector<unsigned int> component_mapping = {});
/**
* Same as above, but for objects of type hp::DoFHandler
& boundary_functions,
const hp::QCollection<dim - 1> & q,
std::map<types::global_dof_index, number> &boundary_values,
- std::vector<unsigned int> component_mapping = {});
+ std::vector<unsigned int> component_mapping = {});
/**
* Call the project_boundary_values() function, see above, with
& boundary_function,
const hp::QCollection<dim - 1> & q,
std::map<types::global_dof_index, number> &boundary_values,
- std::vector<unsigned int> component_mapping = {});
+ std::vector<unsigned int> component_mapping = {});
/**
* Project a function to the boundary of the domain, using the given
*/
template <typename VectorType>
void
- subtract_mean_value(VectorType & v,
- const std::vector<bool> &p_select = {});
+ subtract_mean_value(VectorType &v, const std::vector<bool> &p_select = {});
/**