types::global_dof_index &allocated_size,
::dealii::MemorySpace::MemorySpaceData<Number,
::dealii::MemorySpace::Default>
- &data,
- const MPI_Comm comm_sm)
+ &data,
+ const MPI_Comm /*comm_sm*/)
{
- (void)comm_sm;
-
static_assert(
std::is_same_v<Number, float> || std::is_same_v<Number, double>,
"Number should be float or double for Default memory space");
template <typename MatrixType, typename PreconditionerType>
inline void
initialize_preconditioner(
- const MatrixType &matrix,
+ const MatrixType & /*matrix*/,
std::shared_ptr<PreconditionerType> &preconditioner)
{
- (void)matrix;
(void)preconditioner;
AssertThrow(preconditioner.get() != nullptr, ExcNotInitialized());
}
static void
import_elements(
const std::shared_ptr<const ::dealii::Utilities::MPI::Partitioner>
- &communication_pattern,
- const Number *values,
- const VectorOperation::values operation,
- ::dealii::LinearAlgebra::ReadWriteVector<Number> &rw_vector)
+ & /*communication_pattern*/,
+ const Number * /*values*/,
+ const VectorOperation::values /*operation*/,
+ ::dealii::LinearAlgebra::ReadWriteVector<Number> & /*rw_vector*/)
{
- (void)communication_pattern;
- (void)values;
- (void)operation;
- (void)rw_vector;
-
static_assert(
std::is_same_v<MemorySpace, ::dealii::MemorySpace::Host> ||
std::is_same_v<MemorySpace, ::dealii::MemorySpace::Default>,
{
Assert(s == static_cast<Number>(0),
ExcMessage("Only 0 can be assigned to a vector."));
- (void)s;
const size_type this_size = locally_owned_size();
if (this_size > 0)
const dealii::Vector<Number> &vec,
VectorOperation::values operation,
const std::shared_ptr<const Utilities::MPI::CommunicationPatternBase>
- &communication_pattern)
+ & /*communication_pattern*/)
{
- (void)communication_pattern;
-
internal::import_serial_vector(vec, operation, *this);
}
std::enable_if_t<!has_get_mpi_communicator<SparseMatrixType>,
SparseMatrixType> * = nullptr>
MPI_Comm
- get_mpi_communicator(const SparseMatrixType &sparse_matrix)
+ get_mpi_communicator(const SparseMatrixType & /*sparse_matrix*/)
{
- (void)sparse_matrix;
return MPI_COMM_SELF;
}
* Scale each element of the i-th vector in *this with alpha[i].
*/
virtual void
- MvScale(const std::vector<value_type> &alpha)
+ MvScale(const std::vector<value_type> & /*alpha*/)
{
AssertThrow(false, ExcNotImplemented());
- (void)alpha;
}
/**
* Copy the vectors in A to a set of vectors in *this.
*/
virtual void
- SetBlock(const Belos::MultiVec<value_type> &A,
- const std::vector<int> &index)
+ SetBlock(const Belos::MultiVec<value_type> & /*A*/,
+ const std::vector<int> & /*index*/)
{
AssertThrow(false, ExcNotImplemented());
- (void)A;
- (void)index;
}
/**
* Replace each element of the vectors in *this with alpha.
*/
virtual void
- MvInit(const value_type alpha)
+ MvInit(const value_type /*alpha*/)
{
AssertThrow(false, ExcNotImplemented());
- (void)alpha;
}
/**
* Print *this multivector to the os output stream.
*/
virtual void
- MvPrint(std::ostream &os) const
+ MvPrint(std::ostream & /*os*/) const
{
AssertThrow(false, ExcNotImplemented());
- (void)os;
}
/**
template <int dim>
inline void
HangingNodes<dim>::setup_line_to_cell(
- const Triangulation<dim> &triangulation)
- {
- (void)triangulation;
- }
+ const Triangulation<dim> & /*triangulation*/)
+ {}
VectorType> * = nullptr>
inline void
check_vector_compatibility(
- const VectorType &vec,
- const MatrixFree<dim, Number, VectorizedArrayType> &matrix_free,
- const internal::MatrixFreeFunctions::DoFInfo &dof_info)
+ const VectorType &vec,
+ const MatrixFree<dim, Number, VectorizedArrayType> & /*matrix_free*/,
+ const internal::MatrixFreeFunctions::DoFInfo &dof_info)
{
- (void)vec;
- (void)matrix_free;
- (void)dof_info;
-
AssertDimension(vec.size(), dof_info.vector_partitioner->size());
}
*/
template <int dim>
inline std::vector<Point<dim>>
- generate_simplex_evaluation_points(const unsigned int n_subdivisions)
+ generate_simplex_evaluation_points(const unsigned int /*n_subdivisions*/)
{
- (void)n_subdivisions;
-
DEAL_II_NOT_IMPLEMENTED();
return {};
template <int dim, int spacedim, typename ScalarType>
double
MGDataEntry<dim, spacedim, ScalarType>::get_cell_data_value(
- const unsigned int cell_number,
- const ComponentExtractor extract_component) const
+ const unsigned int /*cell_number*/,
+ const ComponentExtractor /*extract_component*/) const
{
DEAL_II_NOT_IMPLEMENTED();
- (void)cell_number;
- (void)extract_component;
return 0.0;
}
&function,
LinearAlgebra::distributed::Vector<Number> &work_result,
const bool enforce_zero_boundary,
- const Quadrature<dim - 1> &q_boundary,
- const bool project_to_boundary_first)
+ const Quadrature<dim - 1> & /*q_boundary*/,
+ const bool project_to_boundary_first)
{
Assert(project_to_boundary_first == false, ExcNotImplemented());
Assert(enforce_zero_boundary == false, ExcNotImplemented());
- (void)enforce_zero_boundary;
- (void)project_to_boundary_first;
- (void)q_boundary;
AssertDimension(dof.get_fe_collection().size(), 1);
AssertDimension(dof.get_fe(0).n_components(), function.n_components);