* @param factor is an optional multiplication factor for the result.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
cell_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const FEValuesBase<dim> &fetest,
* with its transpose.
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
cell_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const std::vector<Tensor<1, dim>> &input,
* with its transpose.
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
cell_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<Tensor<1, dim>>> &input,
* \f[ r_i = \int_Z (\mathbf w \cdot \nabla)v\, u_i \, dx. \f]
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
cell_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const std::vector<double> &input,
* \cdot\mathbf u_i \, dx. \f]
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
cell_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<double>> &input,
* component is advected by the same velocity.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
upwind_value_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const FEValuesBase<dim> &fetest,
* component is advected by the same velocity.
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
upwind_value_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const std::vector<double> &input,
* component is advected by the same velocity.
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
upwind_value_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<double>> &input,
* component is advected the same way.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
upwind_value_matrix(FullMatrix<double> &M11,
FullMatrix<double> &M12,
FullMatrix<double> &M21,
* component is advected the same way.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
upwind_face_residual(Vector<double> &result1,
Vector<double> &result2,
const FEValuesBase<dim> &fe1,
* component is advected the same way.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
upwind_face_residual(Vector<double> &result1,
Vector<double> &result2,
const FEValuesBase<dim> &fe1,
* <b>H</b><sup>div</sup>. The test functions may be discontinuous.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
cell_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const FEValuesBase<dim> &fetest,
* with respect to the test functions.
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
cell_residual(Vector<number> &result,
const FEValuesBase<dim> &fetest,
const ArrayView<const std::vector<Tensor<1, dim>>> &input,
* this function with respect to the test functions.
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
cell_residual(Vector<number> &result,
const FEValuesBase<dim> &fetest,
const ArrayView<const std::vector<double>> &input,
* <i>H</i><sup>1</sup>. The test functions can be discontinuous.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
gradient_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const FEValuesBase<dim> &fetest,
* function with respect to the test functions.
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
gradient_residual(Vector<number> &result,
const FEValuesBase<dim> &fetest,
const std::vector<Tensor<1, dim>> &input,
* of this function with respect to the test functions.
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
gradient_residual(Vector<number> &result,
const FEValuesBase<dim> &fetest,
const std::vector<double> &input,
* @f[ \int_F (\mathbf u\cdot \mathbf n) v \,ds @f]
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
u_dot_n_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const FEValuesBase<dim> &fetest,
* @f]
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
u_dot_n_residual(Vector<number> &result,
const FEValuesBase<dim> &fe,
const FEValuesBase<dim> &fetest,
* @f]
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
u_times_n_residual(Vector<number> &result,
const FEValuesBase<dim> &fetest,
const std::vector<double> &data,
* @f]
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
u_dot_n_matrix(FullMatrix<double> &M11,
FullMatrix<double> &M12,
FullMatrix<double> &M21,
* @f]
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
u_dot_n_jump_matrix(FullMatrix<double> &M11,
FullMatrix<double> &M12,
FullMatrix<double> &M21,
* element has to be equal to the space dimension.
*/
template <int dim>
- double
+ DEAL_II_DEPRECATED_EARLY double
norm(const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<Tensor<1, dim>>> &Du)
{
* \f[ \int_Z \varepsilon(u): \varepsilon(v)\,dx \f]
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
cell_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const double factor = 1.)
* \f[ - \int_Z \varepsilon(u): \varepsilon(v) \,dx \f]
*/
template <int dim, typename number>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
cell_residual(Vector<number> &result,
const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<Tensor<1, dim>>> &input,
* @f]
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
nitsche_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
double penalty,
* @f]
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
nitsche_tangential_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
double penalty,
* the usual penalty parameter.
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
nitsche_residual(Vector<number> &result,
const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<double>> &input,
* @f]
*/
template <int dim, typename number>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
nitsche_tangential_residual(
Vector<number> &result,
const FEValuesBase<dim> &fe,
* penalty parameter.
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
nitsche_residual_homogeneous(
Vector<number> &result,
const FEValuesBase<dim> &fe,
* The interior penalty flux for symmetric gradients.
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
ip_matrix(FullMatrix<double> &M11,
FullMatrix<double> &M12,
FullMatrix<double> &M21,
* Elasticity residual term for the symmetric interior penalty method.
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
ip_residual(Vector<number> &result1,
Vector<number> &result2,
const FEValuesBase<dim> &fe1,
* @f]
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
cell_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
double factor = 1.)
* @f]
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
cell_residual(Vector<number> &result,
const FEValuesBase<dim> &fetest,
const ArrayView<const std::vector<Tensor<1, dim>>> &input,
* @f]
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
nitsche_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
double penalty,
* argument <tt>data</tt>. $\gamma$ is the usual penalty parameter.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
nitsche_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<double>> &input,
* The interior penalty flux for the grad-div operator. See
* ip_residual() for details.
*/
-
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
ip_matrix(FullMatrix<double> &M11,
FullMatrix<double> &M12,
FullMatrix<double> &M21,
* See for instance Hansbo and Larson, 2002
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
ip_residual(Vector<double> &result1,
Vector<double> &result2,
const FEValuesBase<dim> &fe1,
* @param factor A constant that multiplies the mass matrix.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
mass_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const double factor = 1.)
* quadrature points in the element).
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
weighted_mass_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const std::vector<double> &weights)
* @param factor A constant that multiplies the result.
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
L2(Vector<number> &result,
const FEValuesBase<dim> &fe,
const std::vector<double> &input,
* @param factor A constant that multiplies the result.
*/
template <int dim, typename number>
- void
+ DEAL_II_DEPRECATED_EARLY void
L2(Vector<number> &result,
const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<double>> &input,
* second cell.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
jump_matrix(FullMatrix<double> &M11,
FullMatrix<double> &M12,
FullMatrix<double> &M21,
* latter case, the Laplacian is applied to each component separately.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
cell_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const double factor = 1.)
* \f[ \int_Z \nu \nabla u \cdot \nabla v \, dx. \f]
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
cell_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const std::vector<Tensor<1, dim>> &input,
* \f[ \int_Z \nu \nabla u : \nabla v \, dx. \f]
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
cell_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<Tensor<1, dim>>> &input,
* compute_penalty().
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
nitsche_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
double penalty,
* compute_penalty().
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
nitsche_tangential_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
double penalty,
* argument <tt>data</tt>. $\gamma$ is the usual penalty parameter.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
nitsche_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const std::vector<double> &input,
* argument <tt>data</tt>. $\gamma$ is the usual penalty parameter.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
nitsche_residual(Vector<double> &result,
const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<double>> &input,
* has to be computed accordingly.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
ip_matrix(FullMatrix<double> &M11,
FullMatrix<double> &M12,
FullMatrix<double> &M21,
* @warning This function is still under development!
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
ip_tangential_matrix(FullMatrix<double> &M11,
FullMatrix<double> &M12,
FullMatrix<double> &M21,
* @f]
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
ip_residual(Vector<double> &result1,
Vector<double> &result2,
const FEValuesBase<dim> &fe1,
* @f]
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
ip_residual(Vector<double> &result1,
Vector<double> &result2,
const FEValuesBase<dim> &fe1,
* <i>Z<sub>i</sub></i> orthogonal to the current face.
*/
template <int dim, int spacedim, typename number>
- double
+ DEAL_II_DEPRECATED_EARLY double
compute_penalty(const MeshWorker::DoFInfo<dim, spacedim, number> &dinfo1,
const MeshWorker::DoFInfo<dim, spacedim, number> &dinfo2,
unsigned int deg1,
/**
* @brief Library of integrals over cells and faces
*
+ * @note The contents of this namespace are deprecated and will be removed in
+ * one of the next releases.
+ *
* This namespace contains application specific local integrals for bilinear
* forms, forms and error estimates. It is a collection of functions organized
* into namespaces devoted to certain applications. For instance, the
* for instance duplicate one of the previous.
*/
template <int dim>
- Tensor<1, dim>
- curl_curl(const Tensor<2, dim> &h0,
- const Tensor<2, dim> &h1,
- const Tensor<2, dim> &h2)
+ DEAL_II_DEPRECATED_EARLY Tensor<1, dim>
+ curl_curl(const Tensor<2, dim> &h0,
+ const Tensor<2, dim> &h1,
+ const Tensor<2, dim> &h2)
{
Tensor<1, dim> result;
switch (dim)
* for instance duplicate one of the previous.
*/
template <int dim>
- Tensor<1, dim>
- tangential_curl(const Tensor<1, dim> &g0,
- const Tensor<1, dim> &g1,
- const Tensor<1, dim> &g2,
- const Tensor<1, dim> &normal)
+ DEAL_II_DEPRECATED_EARLY Tensor<1, dim>
+ tangential_curl(const Tensor<1, dim> &g0,
+ const Tensor<1, dim> &g1,
+ const Tensor<1, dim> &g2,
+ const Tensor<1, dim> &normal)
{
Tensor<1, dim> result;
* in weak form.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
curl_curl_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const double factor = 1.)
* functions.
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
curl_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
const FEValuesBase<dim> &fetest,
* @f]
*/
template <int dim>
- void
+ DEAL_II_DEPRECATED_EARLY void
tangential_trace_matrix(FullMatrix<double> &M,
const FEValuesBase<dim> &fe,
double factor = 1.)
* @f]
*/
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
ip_curl_matrix(FullMatrix<double> &M11,
FullMatrix<double> &M12,
FullMatrix<double> &M21,
namespace Patches
{
template <int dim>
- inline void
+ DEAL_II_DEPRECATED_EARLY inline void
points_and_values(Table<2, double> &result,
const FEValuesBase<dim> &fe,
const ArrayView<const std::vector<double>> &input)