modernize-deprecated-headers,
modernize-redundant-void-arg,
modernize-use-emplace,
+ modernize-use-equals-default,
modernize-use-nullptr,
modernize-use-using,
mpi-*,
class Beta
{
public:
- Beta()
- {}
void value_list(const std::vector<Point<dim>> &points,
std::vector<Point<dim>> & values) const;
};
, delta_t(delta_t)
{}
- virtual ~Time()
- {}
+ virtual ~Time() = default;
double current() const
{
Assert(kappa > 0, ExcInternalError());
}
- ~Material_Compressible_Neo_Hook_Three_Field()
- {}
-
// We update the material model with various deformation dependent data
// based on $F$ and the pressure $\widetilde{p}$ and dilatation
// $\widetilde{J}$, and at the end of the function include a physical
, Jc(SymmetricTensor<4, dim>())
{}
- virtual ~PointHistory()
- {}
+ virtual ~PointHistory() = default;
// The first function is used to create a material object and to
// initialize all tensors correctly: The second one updates the stored
const std::string & output_filename,
const ProjectionType surface_projection_kind = NormalProjection);
-
- ~TriangulationOnCAD();
-
void run();
private:
, surface_projection_kind(surface_projection_kind)
{}
- TriangulationOnCAD::~TriangulationOnCAD()
- {}
-
-
// @sect4{TriangulationOnCAD::read_domain}
/**
* Constructor. Initialize all entries to zero.
*/
- DerivativeForm();
+ DerivativeForm() = default;
/**
* Constructor from a tensor.
#ifndef DOXYGEN
-
-
-template <int order, int dim, int spacedim, typename Number>
-inline DerivativeForm<order, dim, spacedim, Number>::DerivativeForm()
-{
- // default constructor. not specifying an initializer list calls
- // the default constructor of the subobjects, which initialize them
- // selves. therefore, the tensor array is set to zero this way
-}
-
-
-
template <int order, int dim, int spacedim, typename Number>
inline DerivativeForm<order, dim, spacedim, Number>::DerivativeForm(
const Tensor<order + 1, dim, Number> &T)
/**
* Copy constructor from @p other iterator.
*/
- IntervalIterator(const IntervalIterator &other);
+ IntervalIterator(const IntervalIterator &other) = default;
/**
* Assignment of another iterator.
*/
IntervalIterator &
- operator=(const IntervalIterator &other);
+ operator=(const IntervalIterator &other) = default;
/**
* Prefix increment.
-inline IndexSet::IntervalIterator::IntervalIterator(
- const IndexSet::IntervalIterator &other)
- : accessor(other.accessor)
-{}
-
-
-
-inline IndexSet::IntervalIterator &
-IndexSet::IntervalIterator::operator=(const IntervalIterator &other)
-{
- accessor = other.accessor;
- return *this;
-}
-
-
-
inline IndexSet::IntervalIterator &
IndexSet::IntervalIterator::operator++()
{
// At least clang-3.7 requires us to have a user-defined constructor
// and we can't use 'Point<dim,Number>::Point () = default' here.
template <int dim, typename Number>
-inline Point<dim, Number>::Point()
+inline Point<dim, Number>::Point() // NOLINT
{}
const Quadrature<dim> &mass_quadrature,
const Quadrature<dim> &data_quadrature);
- /**
- * Destructor.
- */
- ~ContinuousQuadratureDataTransfer();
-
/**
* Prepare for coarsening and refinement of a triangulation @p tria .
* @p data_storage represents the cell data which should be transferred
- template <int dim, typename DataType>
- ContinuousQuadratureDataTransfer<dim, DataType>::
- ~ContinuousQuadratureDataTransfer()
- {}
-
-
-
template <int dim, typename DataType>
void
ContinuousQuadratureDataTransfer<dim, DataType>::
* @note This function can also be used in CUDA device code.
*/
DEAL_II_CUDA_HOST_DEV
- Tensor();
+ Tensor() = default;
/**
* Constructor, where the data is copied from a C-style array.
/*-------------------- Inline functions: Tensor<rank,dim> --------------------*/
-template <int rank_, int dim, typename Number>
-inline DEAL_II_ALWAYS_INLINE DEAL_II_CUDA_HOST_DEV
- Tensor<rank_, dim, Number>::Tensor()
-{
- // All members of the c-style array values are already default initialized
- // and thus all values are already set to zero recursively.
-}
-
-
template <int rank_, int dim, typename Number>
inline DEAL_II_ALWAYS_INLINE
Tensor<rank_, dim, Number>::Tensor(const array_type &initializer)
* automatically generated destructor would have a different one due to
* member objects.
*/
- virtual ~DistortedCellList() noexcept override;
+ virtual ~DistortedCellList() noexcept override = default;
/**
* A list of those cells among the coarse mesh cells that are deformed or
/**
* Virtual destructor.
*/
- virtual ~SolverBicgstab() override;
+ virtual ~SolverBicgstab() override = default;
/**
* Solve primal problem only.
-template <typename VectorType>
-SolverBicgstab<VectorType>::~SolverBicgstab()
-{}
-
-
-
template <typename VectorType>
template <typename MatrixType>
double
/**
* Destructor
*/
- ~SolverSelector() override;
+ virtual ~SolverSelector() override = default;
/**
* Solver procedure. Calls the @p solve function of the @p solver whose @p
-template <typename VectorType>
-SolverSelector<VectorType>::~SolverSelector()
-{}
-
-
-
template <typename VectorType>
void
SolverSelector<VectorType>::select(const std::string &name)
const unsigned int quad_no = 0,
const unsigned int first_selected_component = 0);
- /**
- * Destructor.
- */
- ~FEFaceEvaluation();
-
/**
* Initializes the operation pointer to the current face. This method is the
* default choice for face integration as the data stored in MappingInfo is
-template <int dim,
- int fe_degree,
- int n_q_points_1d,
- int n_components_,
- typename Number>
-inline FEFaceEvaluation<dim, fe_degree, n_q_points_1d, n_components_, Number>::
- ~FEFaceEvaluation()
-{}
-
-
-
template <int dim,
int fe_degree,
int n_q_points_1d,
template <int dim, typename Number>
struct MappingInfo
{
- /**
- * Empty constructor.
- */
- MappingInfo();
-
/**
* Compute the information in the given cells and faces. The cells are
* specified by the level and the index within the level (as given by
/* ------------------------ MappingInfo implementation ----------------- */
- template <int dim, typename Number>
- MappingInfo<dim, Number>::MappingInfo()
- {}
-
-
-
template <int dim, typename Number>
void
MappingInfo<dim, Number>::clear()
struct MFWorkerInterface
{
public:
- virtual ~MFWorkerInterface()
- {}
+ virtual ~MFWorkerInterface() = default;
/// Starts the communication for the update ghost values operation
virtual void
/**
* Destructor.
*/
- ~ParticleHandler() override;
+ virtual ~ParticleHandler() override = default;
/**
* Initialize the particle handler. This function does not clear the
}
-
-template <int dim, int spacedim>
-Triangulation<dim, spacedim>::DistortedCellList::~DistortedCellList() noexcept
-{
- // don't do anything here. the compiler will automatically convert
- // any exceptions created by the destructors of the member variables
- // into abort() in order to satisfy the throw()/noexcept
- // specification
-}
-
-
// explicit instantiations
#include "tria.inst"
- template <int dim, int spacedim>
- ParticleHandler<dim, spacedim>::~ParticleHandler()
- {}
-
-
-
template <int dim, int spacedim>
void
ParticleHandler<dim, spacedim>::initialize(