* use try_read() instead.
*/
template <typename type>
- const type
+ type
entry(const std::string &name) const;
/**
* Use read_ptr() instead!
*/
template <typename type>
- const type
+ type
read(const std::string &name) const;
/**
/// Read-only access to stored data object by index.
template <typename type>
- const type
+ type
entry(const unsigned int i) const;
/// Dedicated read only access.
template <typename type>
- const type
+ type
read(const unsigned int i) const;
/// Dedicated read only access to pointer object.
template <typename type>
-inline const type
+inline type
AnyData::entry(const unsigned int i) const
{
AssertIndexRange(i, size());
template <typename type>
-inline const type
+inline type
AnyData::read(const unsigned int i) const
{
AssertIndexRange(i, size());
template <typename type>
-inline const type
+inline type
AnyData::entry(const std::string &n) const
{
const unsigned int i = find(n);
template <typename type>
-inline const type
+inline type
AnyData::read(const std::string &n) const
{
const unsigned int i = find(n);
/**
* Return the value of <tt>id</tt>.
*/
- const std::string
+ std::string
operator()() const;
/**
* Return a vector of the ranks (within @p comm_large) of a subset of
* processes specified by @p comm_small.
*/
- const std::vector<unsigned int>
+ std::vector<unsigned int>
mpi_processes_within_communicator(const MPI_Comm comm_large,
const MPI_Comm comm_small);
/**
* Main function to compute the co-efficients of the polynomial at degree p.
*/
- static const std::vector<double>
+ static std::vector<double>
get_coefficients(const unsigned int k);
};
* </tr>
* </table>
*/
- const std::string
+ std::string
get_current_vectorization_level();
/**
const std::set<types::subdomain_id> &
level_ghost_owners() const;
- const std::weak_ptr<const Utilities::MPI::Partitioner>
+ std::weak_ptr<const Utilities::MPI::Partitioner>
global_active_cell_index_partitioner() const override;
- const std::weak_ptr<const Utilities::MPI::Partitioner>
+ std::weak_ptr<const Utilities::MPI::Partitioner>
global_level_cell_index_partitioner(
const unsigned int level) const override;
/**
* Return enrichment functions
*/
- const std::vector<std::vector<std::function<const Function<spacedim> *(
+ std::vector<std::vector<std::function<const Function<spacedim> *(
const typename Triangulation<dim, spacedim>::cell_iterator &)>>>
get_enrichments() const;
* The @p cell_index is either 0 or 1 and corresponds to the cell index
* returned by interface_dof_to_cell_and_dof_index().
*/
- const typename Triangulation<dim, spacedim>::cell_iterator
+ typename Triangulation<dim, spacedim>::cell_iterator
get_cell(const unsigned int cell_index) const;
/**
* The concept of views is explained in the documentation of the namespace
* FEValuesViews.
*/
- const FEInterfaceViews::Scalar<dim, spacedim>
+ FEInterfaceViews::Scalar<dim, spacedim>
operator[](const FEValuesExtractors::Scalar &scalar) const;
/**
* finite element. The concept of views is explained in the documentation of
* the namespace FEValuesViews.
*/
- const FEInterfaceViews::Vector<dim, spacedim>
+ FEInterfaceViews::Vector<dim, spacedim>
operator[](const FEValuesExtractors::Vector &vector) const;
/**
template <int dim, int spacedim>
-const typename Triangulation<dim, spacedim>::cell_iterator
+typename Triangulation<dim, spacedim>::cell_iterator
FEInterfaceValues<dim, spacedim>::get_cell(const unsigned int cell_index) const
{
return get_fe_face_values(cell_index).get_cell();
/*------------ Inline functions: FEInterfaceValues------------*/
template <int dim, int spacedim>
-inline const FEInterfaceViews::Scalar<dim, spacedim>
+inline FEInterfaceViews::Scalar<dim, spacedim>
FEInterfaceValues<dim, spacedim>::operator[](
const FEValuesExtractors::Scalar &scalar) const
{
template <int dim, int spacedim>
-inline const FEInterfaceViews::Vector<dim, spacedim>
+inline FEInterfaceViews::Vector<dim, spacedim>
FEInterfaceValues<dim, spacedim>::operator[](
const FEValuesExtractors::Vector &vector) const
{
/**
* Return a triangulation iterator to the current cell.
*/
- const typename Triangulation<dim, spacedim>::cell_iterator
+ typename Triangulation<dim, spacedim>::cell_iterator
get_cell() const;
/**
* level of the triangulation, which is returned by the function
* CellAccessor::global_active_cell_index().
*/
- virtual const std::weak_ptr<const Utilities::MPI::Partitioner>
+ virtual std::weak_ptr<const Utilities::MPI::Partitioner>
global_active_cell_index_partitioner() const;
/**
* level of the triangulation, which is returned by the function
* CellAccessor::global_level_cell_index().
*/
- virtual const std::weak_ptr<const Utilities::MPI::Partitioner>
+ virtual std::weak_ptr<const Utilities::MPI::Partitioner>
global_level_cell_index_partitioner(const unsigned int level) const;
/**
* @return A range object for the half open range <code>[this->begin(),
* this->end())</code> of line entries.
*/
- const LineRange
+ LineRange
get_lines() const;
/**
template <typename number>
-const typename AffineConstraints<number>::LineRange
+typename AffineConstraints<number>::LineRange
AffineConstraints<number>::get_lines() const
{
return boost::make_iterator_range(lines.begin(), lines.end());
* Return the two function objects that are in use for determining the first
* and the next cell as set by set_cell_selection().
*/
- const std::pair<FirstCellFunctionType, NextCellFunctionType>
+ std::pair<FirstCellFunctionType, NextCellFunctionType>
get_cell_selection() const;
private:
*
* @return An ArrayView of the properties of this particle.
*/
- const ArrayView<double>
+ ArrayView<double>
get_properties();
/**
*
* @return An ArrayView of the properties of this particle.
*/
- const ArrayView<const double>
+ ArrayView<const double>
get_properties() const;
/**
template <int dim, int spacedim>
- inline const ArrayView<const double>
+ inline ArrayView<const double>
Particle<dim, spacedim>::get_properties() const
{
if (has_properties() == false)
*
* @return An ArrayView of the properties of this particle.
*/
- const ArrayView<double>
+ ArrayView<double>
get_properties();
/**
*
* @return An ArrayView of the properties of this particle.
*/
- const ArrayView<const double>
+ ArrayView<const double>
get_properties() const;
/**
template <int dim, int spacedim>
- inline const ArrayView<const double>
+ inline ArrayView<const double>
ParticleAccessor<dim, spacedim>::get_properties() const
{
Assert(state() == IteratorState::valid, ExcInternalError());
template <int dim, int spacedim>
- inline const ArrayView<double>
+ inline ArrayView<double>
ParticleAccessor<dim, spacedim>::get_properties()
{
Assert(state() == IteratorState::valid, ExcInternalError());
}
-const std::string
+std::string
JobIdentifier::operator()() const
{
return id;
- const std::vector<unsigned int>
+ std::vector<unsigned int>
mpi_processes_within_communicator(const MPI_Comm comm_large,
const MPI_Comm comm_small)
{
- const std::vector<unsigned int>
+ std::vector<unsigned int>
mpi_processes_within_communicator(const MPI_Comm, const MPI_Comm)
{
return std::vector<unsigned int>{0};
-const std::vector<double>
+std::vector<double>
IntegratedLegendreSZ::get_coefficients(const unsigned int k)
{
std::vector<double> coefficients(k + 1);
#endif
- const std::string
+ std::string
get_current_vectorization_level()
{
switch (DEAL_II_VECTORIZATION_WIDTH_IN_BITS)
template <int dim, int spacedim>
DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
- const std::weak_ptr<const Utilities::MPI::Partitioner> TriangulationBase<
+ std::weak_ptr<const Utilities::MPI::Partitioner> TriangulationBase<
dim,
spacedim>::global_active_cell_index_partitioner() const
{
template <int dim, int spacedim>
DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
- const std::weak_ptr<const Utilities::MPI::Partitioner> TriangulationBase<
- dim,
- spacedim>::global_level_cell_index_partitioner(const unsigned int level)
- const
+ std::weak_ptr<const Utilities::MPI::Partitioner> TriangulationBase<dim,
+ spacedim>::
+ global_level_cell_index_partitioner(const unsigned int level) const
{
Assert(this->is_multilevel_hierarchy_constructed(), ExcNotImplemented());
AssertIndexRange(level, this->n_global_levels());
template <int dim, int spacedim>
-const std::vector<std::vector<std::function<const Function<spacedim> *(
+std::vector<std::vector<std::function<const Function<spacedim> *(
const typename Triangulation<dim, spacedim>::cell_iterator &)>>>
FE_Enriched<dim, spacedim>::get_enrichments() const
{
template <int dim, int spacedim>
-const typename Triangulation<dim, spacedim>::cell_iterator
+typename Triangulation<dim, spacedim>::cell_iterator
FEValuesBase<dim, spacedim>::get_cell() const
{
return present_cell;
template <int dim, int spacedim>
DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
-const std::weak_ptr<const Utilities::MPI::Partitioner> Triangulation<
- dim,
- spacedim>::global_active_cell_index_partitioner() const
+std::weak_ptr<const Utilities::MPI::Partitioner> Triangulation<dim, spacedim>::
+ global_active_cell_index_partitioner() const
{
return number_cache.active_cell_index_partitioner;
}
template <int dim, int spacedim>
DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
-const std::weak_ptr<const Utilities::MPI::Partitioner> Triangulation<
- dim,
- spacedim>::global_level_cell_index_partitioner(const unsigned int level) const
+std::weak_ptr<const Utilities::MPI::Partitioner> Triangulation<dim, spacedim>::
+ global_level_cell_index_partitioner(const unsigned int level) const
{
AssertIndexRange(level, this->n_levels());
template <int dim, int spacedim>
-const std::pair<typename DataOut<dim, spacedim>::FirstCellFunctionType,
- typename DataOut<dim, spacedim>::NextCellFunctionType>
+std::pair<typename DataOut<dim, spacedim>::FirstCellFunctionType,
+ typename DataOut<dim, spacedim>::NextCellFunctionType>
DataOut<dim, spacedim>::get_cell_selection() const
{
return std::make_pair(first_cell_function, next_cell_function);
template <int dim, int spacedim>
- const ArrayView<double>
+ ArrayView<double>
Particle<dim, spacedim>::get_properties()
{
return property_pool->get_properties(property_pool_handle);