template <int dim, int spacedim>
DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
void CellAttachedDataSerializer<dim, spacedim>::save(
- const unsigned int global_first_cell,
- const unsigned int global_num_cells,
- const std::string &file_basename,
- const MPI_Comm &mpi_communicator) const
+ [[maybe_unused]] const unsigned int global_first_cell,
+ [[maybe_unused]] const unsigned int global_num_cells,
+ const std::string &file_basename,
+ [[maybe_unused]] const MPI_Comm &mpi_communicator) const
{
Assert(sizes_fixed_cumulative.size() > 0,
ExcMessage("No data has been packed!"));
else
#endif
{
- (void)global_first_cell;
- (void)global_num_cells;
- (void)mpi_communicator;
-
//
// ---------- Fixed size data ----------
//
template <int dim, int spacedim>
DEAL_II_CXX20_REQUIRES((concepts::is_valid_dim_spacedim<dim, spacedim>))
void CellAttachedDataSerializer<dim, spacedim>::load(
- const unsigned int global_first_cell,
- const unsigned int global_num_cells,
- const unsigned int local_num_cells,
- const std::string &file_basename,
- const unsigned int n_attached_deserialize_fixed,
- const unsigned int n_attached_deserialize_variable,
- const MPI_Comm &mpi_communicator)
+ [[maybe_unused]] const unsigned int global_first_cell,
+ [[maybe_unused]] const unsigned int global_num_cells,
+ const unsigned int local_num_cells,
+ const std::string &file_basename,
+ const unsigned int n_attached_deserialize_fixed,
+ const unsigned int n_attached_deserialize_variable,
+ const MPI_Comm &mpi_communicator)
{
Assert(dest_data_fixed.empty(),
ExcMessage("Previously loaded data has not been released yet!"));
#endif
{
(void)mpi_communicator;
- (void)global_first_cell;
- (void)global_num_cells;
//
// ---------- Fixed size data ----------