CopyData(const CopyData &) = default;
+ CopyData(CopyData &&) = default;
+
+
+ ~CopyData() = default;
+
+
+ CopyData &operator=(const CopyData &) = default;
+
+
+ CopyData &operator=(CopyData &&) = default;
+
+
struct FaceData
{
FullMatrix<double> cell_matrix;
const int index,
const DoFHandler<dim, spacedim> * dof_handler);
+ /**
+ * Copy constructor.
+ */
+ DoFAccessor(const DoFAccessor<structdim, dim, spacedim, level_dof_access> &) =
+ default;
+
+ /**
+ * Move constructor.
+ */
+ DoFAccessor(DoFAccessor<structdim, dim, spacedim, level_dof_access>
+ &&) noexcept = default;
+
+ /**
+ * Destructor.
+ */
+ ~DoFAccessor() = default;
+
/**
* Conversion constructor. This constructor exists to make certain
* constructs simpler to write in dimension independent code. For example,
operator=(const DoFAccessor<structdim, dim, spacedim, level_dof_access> &da) =
delete;
+ /**
+ * Move assignment operator.
+ */
+ DoFAccessor<structdim, dim, spacedim, level_dof_access> &
+ operator=(DoFAccessor<structdim, dim, spacedim, level_dof_access>
+ &&) noexcept = default;
+
/**
* @}
*/
DoFAccessor(
const DoFAccessor<structdim2, dim2, spacedim2, level_dof_access2> &);
+ /**
+ * Copy constructor.
+ */
+ DoFAccessor(const DoFAccessor<0, 1, spacedim, level_dof_access> &) = default;
+
+ /**
+ * Move constructor.
+ */
+ // NOLINTNEXTLINE OSX does not compile with noexcept
+ DoFAccessor(DoFAccessor<0, 1, spacedim, level_dof_access> &&) = default;
+
+ /**
+ * Destructor.
+ */
+ ~DoFAccessor() = default;
+
/**
* Copy operator. These operators are usually used in a context like
* <tt>iterator a,b; *a=*b;</tt>. Presumably, the intent here is to copy the
DoFAccessor<0, 1, spacedim, level_dof_access> &
operator=(const DoFAccessor<0, 1, spacedim, level_dof_access> &da) = delete;
+ /**
+ * Move assignment operator.
+ */
+ DoFAccessor<0, 1, spacedim, level_dof_access> &operator =(
+ DoFAccessor<0, 1, spacedim, level_dof_access> &&) noexcept = default;
+
/**
* @}
*/
explicit DoFCellAccessor(
const DoFAccessor<structdim2, dim2, spacedim2, level_dof_access2> &);
+ /**
+ * Copy constructor.
+ */
+ DoFCellAccessor(
+ const DoFCellAccessor<dimension_, space_dimension_, level_dof_access> &) =
+ default;
+
+ /**
+ * Move constructor.
+ */
+ DoFCellAccessor(
+ DoFCellAccessor<dimension_, space_dimension_, level_dof_access>
+ &&) noexcept = default;
+
+ /**
+ * Destructor
+ */
+ ~DoFCellAccessor() = default;
+
/**
* Copy operator. These operators are usually used in a context like
* <tt>iterator a,b; *a=*b;</tt>. Presumably, the intent here is to copy the
const DoFCellAccessor<dimension_, space_dimension_, level_dof_access> &da) =
delete;
+ /**
+ * Move assignment operator.
+ */
+ DoFCellAccessor<dimension_, space_dimension_, level_dof_access> &
+ operator=(DoFCellAccessor<dimension_, space_dimension_, level_dof_access>
+ &&) noexcept = default;
+
/**
* @}
*/
Scalar(const FEValuesBase<dim, spacedim> &fe_values_base,
const unsigned int component);
+ /**
+ * Copy constructor. This is not a lightweight object so we don't allow
+ * copying and generate a compile-time error if this function is called.
+ */
+ Scalar(const Scalar<dim, spacedim> &) = delete;
+
+ /**
+ * Move constructor.
+ */
+ // NOLINTNEXTLINE OSX does not compile with noexcept
+ Scalar(Scalar<dim, spacedim> &&) = default;
+
+ /**
+ * Destructor.
+ */
+ ~Scalar() = default;
+
/**
* Copy operator. This is not a lightweight object so we don't allow
* copying and generate a compile-time error if this function is called.
Scalar &
operator=(const Scalar<dim, spacedim> &) = delete;
+ /**
+ * Move assignment operator.
+ */
+ Scalar &
+ operator=(Scalar<dim, spacedim> &&) noexcept = default;
+
/**
* Return the value of the vector component selected by this view, for the
* shape function and quadrature point selected by the arguments.
Vector(const FEValuesBase<dim, spacedim> &fe_values_base,
const unsigned int first_vector_component);
+ /**
+ * Copy constructor. This is not a lightweight object so we don't allow
+ * copying and generate a compile-time error if this function is called.
+ */
+ Vector(const Vector<dim, spacedim> &) = delete;
+
+ /**
+ * Move constuctor.
+ */
+ // NOLINTNEXTLINE OSX does not compile with noexcept
+ Vector(Vector<dim, spacedim> &&) = default;
+
+ /**
+ * Destructor.
+ */
+ ~Vector() = default;
+
/**
* Copy operator. This is not a lightweight object so we don't allow
* copying and generate a compile-time error if this function is called.
Vector &
operator=(const Vector<dim, spacedim> &) = delete;
+ /**
+ * Move assignment operator.
+ */
+ // NOLINTNEXTLINE OSX does not compile with noexcept
+ Vector &
+ operator=(Vector<dim, spacedim> &&) = default; // NOLINT
+
/**
* Return the value of the vector components selected by this view, for
* the shape function and quadrature point selected by the arguments.
SymmetricTensor(const FEValuesBase<dim, spacedim> &fe_values_base,
const unsigned int first_tensor_component);
+ /**
+ * Copy constructor. This is not a lightweight object so we don't allow
+ * copying and generate a compile-time error if this function is called.
+ */
+ SymmetricTensor(const SymmetricTensor<2, dim, spacedim> &) = delete;
+
+ /**
+ * Move constructor.
+ */
+ // NOLINTNEXTLINE OSX does not compile with noexcept
+ SymmetricTensor(SymmetricTensor<2, dim, spacedim> &&) = default;
+
/**
* Copy operator. This is not a lightweight object so we don't allow
* copying and generate a compile-time error if this function is called.
SymmetricTensor &
operator=(const SymmetricTensor<2, dim, spacedim> &) = delete;
+ /**
+ * Move assignment operator.
+ */
+ SymmetricTensor &
+ operator=(SymmetricTensor<2, dim, spacedim> &&) noexcept = default;
+
/**
* Return the value of the vector components selected by this view, for
* the shape function and quadrature point selected by the arguments.
*/
Tensor();
+ /**
+ * Copy constructor. This is not a lightweight object so we don't allow
+ * copying and generate a compile-time error if this function is called.
+ */
+ Tensor(const Tensor<2, dim, spacedim> &) = delete;
+
+ /**
+ * Move constructor.
+ */
+ // NOLINTNEXTLINE OSX does not compile with noexcept
+ Tensor(Tensor<2, dim, spacedim> &&) = default;
+
+ /**
+ * Destructor.
+ */
+ ~Tensor() = default;
+
/**
* Constructor for an object that represents <code>(dim*dim)</code>
* components of a FEValuesBase object (or of one of the classes derived
Tensor &
operator=(const Tensor<2, dim, spacedim> &) = delete;
+ /**
+ * Move assignment operator.
+ */
+ // NOLINTNEXTLINE
+ Tensor &operator=(Tensor<2, dim, spacedim> &&) = default;
+
/**
* Return the value of the vector components selected by this view, for
* the shape function and quadrature point selected by the arguments.
template <int structdim2, int dim2, int spacedim2>
CellAccessor(const TriaAccessor<structdim2, dim2, spacedim2> &);
+ /**
+ * Copy constructor.
+ */
+ CellAccessor(const CellAccessor<dim, spacedim> &) = default;
+
+ /**
+ * Move constructor.
+ */
+ // NOLINTNEXTLINE OSX does not compile with noexcept
+ CellAccessor(CellAccessor<dim, spacedim> &&) = default;
+
+ /**
+ * Destructor.
+ */
+ ~CellAccessor() = default;
+
/**
* Copy operator. These operators are usually used in a context like
* <tt>iterator a,b; *a=*b;</tt>. Presumably, the intent here is to copy the
* this operation is not useful for iterators on triangulations.
* Consequently, this operator is declared as deleted and can not be used.
*/
- void
+ CellAccessor<dim, spacedim> &
operator=(const CellAccessor<dim, spacedim> &) = delete;
+ /**
+ * Move assignment operator.
+ */
+ // NOLINTNEXTLINE OSX does not compile with noexcept
+ CellAccessor<dim, spacedim> &
+ operator=(CellAccessor<dim, spacedim> &&) = default; // NOLINT
+
/**
* @}
*/
*/
DoFInfo(const DoFInfo &) = default;
+ /**
+ * Move constructor.
+ */
+ DoFInfo(DoFInfo &&) noexcept = default;
+
+ /**
+ * Destructor.
+ */
+ ~DoFInfo() = default;
+
+ /**
+ * Copy assignment operator.
+ */
+ DoFInfo &
+ operator=(const DoFInfo &) = default;
+
+ /**
+ * Move assignment operator.
+ */
+ DoFInfo &
+ operator=(DoFInfo &&) noexcept = default;
+
/**
* Clear all data fields in this class.
*/