* @relatesalso ArrayView
*/
template <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED_EARLY inline ArrayView<const Number>
+DEAL_II_DEPRECATED inline ArrayView<const Number>
make_array_view(const Tensor<rank, dim, Number> &tensor)
{
return make_array_view(tensor.begin_raw(), tensor.end_raw());
* @relatesalso ArrayView
*/
template <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED_EARLY inline ArrayView<Number>
+DEAL_II_DEPRECATED inline ArrayView<Number>
make_array_view(Tensor<rank, dim, Number> &tensor)
{
return make_array_view(tensor.begin_raw(), tensor.end_raw());
* @relatesalso ArrayView
*/
template <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED_EARLY inline ArrayView<const Number>
+DEAL_II_DEPRECATED inline ArrayView<const Number>
make_array_view(const SymmetricTensor<rank, dim, Number> &tensor)
{
return make_array_view(tensor.begin_raw(), tensor.end_raw());
* @relatesalso ArrayView
*/
template <int rank, int dim, typename Number>
-DEAL_II_DEPRECATED_EARLY inline ArrayView<Number>
+DEAL_II_DEPRECATED inline ArrayView<Number>
make_array_view(SymmetricTensor<rank, dim, Number> &tensor)
{
return make_array_view(tensor.begin_raw(), tensor.end_raw());
* @deprecated Use MPI_Comm_create_group directly
*/
#ifdef DEAL_II_WITH_MPI
- DEAL_II_DEPRECATED_EARLY int
+ DEAL_II_DEPRECATED int
create_group(const MPI_Comm & comm,
const MPI_Group &group,
const int tag,
* and one should not pretend that this so. As a consequence, this function
* is deprecated.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
Number *
begin_raw();
* and one should not pretend that this so. As a consequence, this function
* is deprecated.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
const Number *
begin_raw() const;
* and one should not pretend that this so. As a consequence, this function
* is deprecated.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
Number *
end_raw();
* and one should not pretend that this so. As a consequence, this function
* is deprecated.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
const Number *
end_raw() const;
* and one should not pretend that this so. As a consequence, this function
* is deprecated.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
Number *
begin_raw();
* and one should not pretend that this so. As a consequence, this function
* is deprecated.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
const Number *
begin_raw() const;
* and one should not pretend that this so. As a consequence, this function
* is deprecated.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
Number *
end_raw();
* and one should not pretend that this so. As a consequence, this function
* is deprecated.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
const Number *
end_raw() const;
* instead.
*/
template <typename OtherNumber>
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
unroll(Vector<OtherNumber> &result) const;
/**
*
* @deprecated The autopartition parameter has been removed.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
virtual void
load(const std::string &filename, const bool autopartition) override;
*
* @deprecated The autopartition parameter has been removed.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
virtual void
load(const std::string &filename, const bool autopartition) override;
* This function is not implemented, but needs to be present for the
* compiler.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
virtual void
load(const std::string &filename, const bool autopartition) override;
* Dummy replacement to allow for better error messages when compiling
* this class.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
virtual void
load(const std::string & /*filename*/,
const bool /*autopartition*/) override
*
* @deprecated The autopartition parameter has been removed.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
virtual void
load(const std::string &filename, const bool autopartition) = 0;
* versions of deal.II, but it does not have any effect on the workings of
* this class.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
MappingQ(const unsigned int polynomial_degree,
const bool use_mapping_q_on_all_cells);
* @deprecated Use the alternative with the unit vector instead.
*/
template <int dim>
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
rotate(const double angle,
const unsigned int axis,
Triangulation<dim, 3> &triangulation);
* Connects an additional base weight function if signal was previously
* empty.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
boost::signals2::connection
connect(
const slot_type & slot,
* Returns the number of connected functions <em>without</em> the base
* weight.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
std::size_t
num_slots() const
{
/**
* Checks if there are any connected functions to the signal.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
bool
empty() const
{
* function.
*/
template <typename S>
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
disconnect(const S &connection)
{
new_signal.disconnect(connection);
/**
* Triggers the signal.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
unsigned int
operator()(const cell_iterator &iterator, const CellStatus status)
{
* Like above but with separate bool flags.
* @deprecated use evaluate() with the EvaluationFlags argument.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
evaluate(const bool evaluate_values,
const bool evaluate_gradients,
const bool evaluate_hessians = false);
* Like above but using separate bool flags.
* @deprecated use evaluate() with the EvaluationFlags argument.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
evaluate(const VectorizedArrayType *values_array,
const bool evaluate_values,
const bool evaluate_gradients,
* @deprecated Please use the gather_evaluate() function with the EvaluationFlags argument.
*/
template <typename VectorType>
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
gather_evaluate(const VectorType &input_vector,
const bool evaluate_values,
const bool evaluate_gradients,
/**
* @deprecated Please use the integrate() function with the EvaluationFlags argument.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
integrate(const bool integrate_values, const bool integrate_gradients);
/**
/**
* @deprecated Please use the integrate() function with the EvaluationFlags argument.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
integrate(const bool integrate_values,
const bool integrate_gradients,
VectorizedArrayType *values_array);
* @deprecated Please use the integrate_scatter() function with the EvaluationFlags argument.
*/
template <typename VectorType>
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
integrate_scatter(const bool integrate_values,
const bool integrate_gradients,
VectorType &output_vector);
/**
* @deprecated Please use the evaluate() function with the EvaluationFlags argument.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
evaluate(const bool evaluate_values, const bool evaluate_gradients);
/**
/**
* @deprecated Please use the evaluate() function with the EvaluationFlags argument.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
evaluate(const VectorizedArrayType *values_array,
const bool evaluate_values,
const bool evaluate_gradients);
* @deprecated Please use the gather_evaluate() function with the EvaluationFlags argument.
*/
template <typename VectorType>
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
gather_evaluate(const VectorType &input_vector,
const bool evaluate_values,
const bool evaluate_gradients);
/**
* @deprecated Please use the integrate() function with the EvaluationFlags argument.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
integrate(const bool integrate_values, const bool integrate_gradients);
/**
/**
* @deprecated Please use the integrate() function with the EvaluationFlags argument.
*/
- DEAL_II_DEPRECATED_EARLY void
+ DEAL_II_DEPRECATED void
integrate(const bool integrate_values,
const bool integrate_gradients,
VectorizedArrayType *values_array);
* and has no meaning any more. ParticleAccessors always use the
* property pool of the owning particle handler.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
void
set_property_pool(PropertyPool<dim, spacedim> &property_pool);
* @deprecated Deprecated version of the function with the same
* name above.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
const typename Triangulation<dim, spacedim>::cell_iterator &
get_surrounding_cell(
const Triangulation<dim, spacedim> &triangulation) const;
* prepare_for_serialization() instead. See there for further information
* about the purpose of this function.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
void
register_store_callback_function();
* deserialize() instead. See there for further information about the
* purpose of this function.
*/
- DEAL_II_DEPRECATED_EARLY
+ DEAL_II_DEPRECATED
void
register_load_callback_function(const bool serialization);
* @deprecated Use the variant with a Tensor as an axis.
*/
template <typename Number>
- DEAL_II_DEPRECATED_EARLY Tensor<2, 3, Number>
+ DEAL_II_DEPRECATED Tensor<2, 3, Number>
rotation_matrix_3d(const Point<3, Number> &axis, const Number &angle);
//@}