ParsedConvergenceTable(
const std::vector<std::string> & component_names,
const std::vector<std::set<VectorTools::NormType>> &list_of_error_norms,
- const double & exponent,
+ const double exponent,
const std::set<std::string> & extra_columns,
const std::string & rate_key,
const std::string & rate_mode,
const std::string & error_file_name,
- const unsigned int & precision,
- const bool & compute_error);
+ const unsigned int precision,
+ const bool compute_error);
/**
* Attach all the parameters in this class to entries of the parameter
void
add_extra_column(const std::string & column_name,
const std::function<double()> &custom_function,
- const bool & compute_rate = true);
+ const bool compute_rate = true);
/**
* Difference between two solutions in the same vector space.
*/
template <typename TensorType, typename NumberType>
inline void
- set_tensor_entry(TensorType & t,
- const unsigned int &unrolled_index,
- const NumberType & value)
+ set_tensor_entry(TensorType & t,
+ const unsigned int unrolled_index,
+ const NumberType & value)
{
// Where possible, set values using TableIndices
AssertIndexRange(unrolled_index, t.n_independent_components);
*/
template <int dim, typename NumberType>
inline void set_tensor_entry(Tensor<0, dim, NumberType> &t,
- const unsigned int & unrolled_index,
+ const unsigned int unrolled_index,
const NumberType & value)
{
AssertIndexRange(unrolled_index, 1);
*/
template <typename NumberType>
inline void
- set_tensor_entry(NumberType & t,
- const unsigned int &unrolled_index,
- const NumberType & value)
+ set_tensor_entry(NumberType & t,
+ const unsigned int unrolled_index,
+ const NumberType & value)
{
AssertIndexRange(unrolled_index, 1);
(void)unrolled_index;
*/
template <int dim, typename NumberType>
inline void set_tensor_entry(SymmetricTensor<4, dim, NumberType> &t,
- const unsigned int &unrolled_index_row,
- const unsigned int &unrolled_index_col,
- const NumberType & value)
+ const unsigned int unrolled_index_row,
+ const unsigned int unrolled_index_col,
+ const NumberType & value)
{
// Fourth order symmetric tensors require a specialized interface
// to extract values.
template <int, int, typename> class TensorType>
inline NumberType
get_tensor_entry(const TensorType<rank, dim, NumberType> &t,
- const unsigned int & unrolled_index)
+ const unsigned int unrolled_index)
{
// Where possible, get values using TableIndices
AssertIndexRange(unrolled_index, t.n_independent_components);
template <int, int, typename> class TensorType>
inline NumberType
get_tensor_entry(const TensorType<0, dim, NumberType> &t,
- const unsigned int & unrolled_index)
+ const unsigned int unrolled_index)
{
AssertIndexRange(unrolled_index, 1);
(void)unrolled_index;
*/
template <typename NumberType>
inline const NumberType &
- get_tensor_entry(const NumberType &t, const unsigned int &unrolled_index)
+ get_tensor_entry(const NumberType &t, const unsigned int unrolled_index)
{
AssertIndexRange(unrolled_index, 1);
(void)unrolled_index;
template <int, int, typename> class TensorType>
inline NumberType &
get_tensor_entry(TensorType<rank, dim, NumberType> &t,
- const unsigned int & unrolled_index)
+ const unsigned int unrolled_index)
{
// Where possible, get values using TableIndices
AssertIndexRange(unrolled_index, t.n_independent_components);
typename NumberType,
template <int, int, typename> class TensorType>
NumberType &get_tensor_entry(TensorType<0, dim, NumberType> &t,
- const unsigned int & index)
+ const unsigned int index)
{
AssertIndexRange(index, 1);
(void)index;
*/
template <typename NumberType>
inline NumberType &
- get_tensor_entry(NumberType &t, const unsigned int &index)
+ get_tensor_entry(NumberType &t, const unsigned int index)
{
AssertIndexRange(index, 1);
(void)index;
* potential ambiguities related to implicit conversions in either user
* code or math functions that are loaded into the standard namespace.
*/
- explicit Expression(const bool &value);
+ explicit Expression(const bool value);
/**
* Constructor for arithmetic number types.
{
template <int dim>
TableIndices<4>
- make_rank_4_tensor_indices(const unsigned int &idx_i,
- const unsigned int &idx_j)
+ make_rank_4_tensor_indices(const unsigned int idx_i,
+ const unsigned int idx_j)
{
const TableIndices<2> indices_i(
SymmetricTensor<2, dim>::unrolled_to_component_indices(idx_i));
template <class CellIteratorType>
void
reinit(const CellIteratorType & cell,
- const unsigned int & face_no,
- const unsigned int & sub_face_no,
+ const unsigned int face_no,
+ const unsigned int sub_face_no,
const typename identity<CellIteratorType>::type &cell_neighbor,
- const unsigned int & face_no_neighbor,
- const unsigned int & sub_face_no_neighbor);
+ const unsigned int face_no_neighbor,
+ const unsigned int sub_face_no_neighbor);
/**
* Re-initialize this object to be used on an interface given by a single face
*/
template <class CellIteratorType>
void
- reinit(const CellIteratorType &cell, const unsigned int &face_no);
+ reinit(const CellIteratorType &cell, const unsigned int face_no);
/**
* Return a reference to the FEFaceValues or FESubfaceValues object
void
FEInterfaceValues<dim, spacedim>::reinit(
const CellIteratorType & cell,
- const unsigned int & face_no,
- const unsigned int & sub_face_no,
+ const unsigned int face_no,
+ const unsigned int sub_face_no,
const typename identity<CellIteratorType>::type &cell_neighbor,
- const unsigned int & face_no_neighbor,
- const unsigned int & sub_face_no_neighbor)
+ const unsigned int face_no_neighbor,
+ const unsigned int sub_face_no_neighbor)
{
if (sub_face_no == numbers::invalid_unsigned_int)
{
template <class CellIteratorType>
void
FEInterfaceValues<dim, spacedim>::reinit(const CellIteratorType &cell,
- const unsigned int & face_no)
+ const unsigned int face_no)
{
internal_fe_face_values.reinit(cell, face_no);
fe_face_values = &internal_fe_face_values;
* all set to numbers::invalid_dof_index.
*/
void
- operator=(const double &number);
+ operator=(const double number);
/**
* An array of local matrices.
template <int n_matrices, int n_vectors, int n_dof_indices>
void
- CopyData<n_matrices, n_vectors, n_dof_indices>::
- operator=(const double &number)
+ CopyData<n_matrices, n_vectors, n_dof_indices>::operator=(const double number)
{
Assert(number == 0.0,
ExcMessage("You should only call this method with "
ParsedConvergenceTable::ParsedConvergenceTable(
const std::vector<std::string> & component_names,
const std::vector<std::set<VectorTools::NormType>> &list_of_error_norms,
- const double & exponent,
+ const double exponent,
const std::set<std::string> & extra_columns,
const std::string & rate_key,
const std::string & rate_mode,
const std::string & error_file_name,
- const unsigned int & precision,
- const bool & compute_error)
+ const unsigned int precision,
+ const bool compute_error)
: component_names(component_names)
, unique_component_names(get_unique_component_names(component_names))
, unique_component_masks(get_unique_component_masks(component_names))
ParsedConvergenceTable::add_extra_column(
const std::string & column_name,
const std::function<double()> &custom_function,
- const bool & compute_rate)
+ const bool compute_rate)
{
extra_column_functions[column_name] = {custom_function, compute_rate};
}
{}
- Expression::Expression(const bool &value)
+ Expression::Expression(const bool value)
: expression(SE::boolean(value))
{}
i_particle < local_positions[i_cell].size();
++i_particle)
{
- const unsigned int &local_id_on_calling_process =
+ const unsigned int local_id_on_calling_process =
original_indices_of_local_particles[i_cell][i_particle];
- const unsigned int &calling_process =
+ const unsigned int calling_process =
calling_process_indices[i_cell][i_particle];
if (original_process_to_local_particle_indices.find(
i_particle < local_positions[i_cell].size();
++i_particle)
{
- const unsigned int &local_id_on_calling_process =
+ const unsigned int local_id_on_calling_process =
original_indices_of_local_particles[i_cell][i_particle];
- const unsigned int &calling_process =
+ const unsigned int calling_process =
calling_process_indices[i_cell][i_particle];
const unsigned int particle_id =