15#ifndef dealii_integrators_grad_div_h
16#define dealii_integrators_grad_div_h
50 DEAL_II_DEPRECATED_EARLY
void
63 const double dx = factor * fe.
JxW(k);
64 for (
unsigned int i = 0; i < n_dofs; ++i)
65 for (
unsigned int j = 0; j < n_dofs; ++j)
72 M(i, j) += dx * divu * divv;
83 template <
int dim,
typename number>
84 DEAL_II_DEPRECATED_EARLY
void
88 const double factor = 1.)
97 const double dx = factor * fetest.
JxW(k);
98 for (
unsigned int i = 0; i < n_dofs; ++i)
103 for (
unsigned int d = 0; d < dim; ++d)
104 du += input[d][k][d];
106 result(i) += dx * du * divv;
120 DEAL_II_DEPRECATED_EARLY
inline void
134 const double dx = factor * fe.
JxW(k);
136 for (
unsigned int i = 0; i < n_dofs; ++i)
137 for (
unsigned int j = 0; j < n_dofs; ++j)
143 double un = 0., vn = 0.;
144 for (
unsigned int d = 0; d < dim; ++d)
150 M(i, j) += dx * 2. * penalty * un * vn;
151 M(i, j) -= dx * (divu * vn + divv * un);
172 DEAL_II_DEPRECATED_EARLY
void
175 const ArrayView<
const std::vector<double>> &input,
177 const ArrayView<
const std::vector<double>> &data,
189 const double dx = factor * fe.
JxW(k);
194 for (
unsigned int d = 0; d < dim; ++d)
196 umgn += (input[d][k] - data[d][k]) * n[d];
197 divu += Dinput[d][k][d];
200 for (
unsigned int i = 0; i < n_dofs; ++i)
205 for (
unsigned int d = 0; d < dim; ++d)
209 dx * (2. * penalty * umgn * vn - divv * umgn - divu * vn);
219 DEAL_II_DEPRECATED_EARLY
void
228 double factor2 = -1.)
240 const double fi = factor1;
241 const double fe = (factor2 < 0) ? factor1 : factor2;
242 const double f = .5 * (fi + fe);
246 const double dx = fe1.
JxW(k);
248 for (
unsigned int i = 0; i < n_dofs; ++i)
249 for (
unsigned int j = 0; j < n_dofs; ++j)
264 for (
unsigned int d = 0; d < dim; ++d)
272 dx * (-.5 * fi * divvi * uni - .5 * fi * divui * vni +
273 f * penalty * uni * vni);
275 dx * (.5 * fi * divvi * une - .5 * fe * divue * vni -
276 f * penalty * vni * une);
278 dx * (-.5 * fe * divve * uni + .5 * fi * divui * vne -
279 f * penalty * uni * vne);
281 dx * (.5 * fe * divve * une + .5 * fe * divue * vne +
282 f * penalty * une * vne);
299 DEAL_II_DEPRECATED_EARLY
void
304 const ArrayView<
const std::vector<double>> &input1,
306 const ArrayView<
const std::vector<double>> &input2,
309 double int_factor = 1.,
310 double ext_factor = -1.)
320 const double fi = int_factor;
321 const double fe = (ext_factor < 0) ? int_factor : ext_factor;
322 const double penalty = .5 * pen * (fi + fe);
327 const double dx = fe1.
JxW(k);
333 for (
unsigned int d = 0; d < dim; ++d)
335 uni += input1[d][k] * n[d];
336 une += input2[d][k] * n[d];
337 divui += Dinput1[d][k][d];
338 divue += Dinput2[d][k][d];
341 for (
unsigned int i = 0; i < n1; ++i)
349 for (
unsigned int d = 0; d < dim; ++d)
355 result1(i) += dx * (-.5 * fi * divvi * uni -
356 .5 * fi * divui * vni + penalty * uni * vni);
357 result1(i) += dx * (.5 * fi * divvi * une -
358 .5 * fe * divue * vni - penalty * vni * une);
359 result2(i) += dx * (-.5 * fe * divve * uni +
360 .5 * fi * divui * vne - penalty * uni * vne);
361 result2(i) += dx * (.5 * fe * divve * une +
362 .5 * fe * divue * vne + penalty * une * vne);
const unsigned int dofs_per_cell
const Tensor< 1, spacedim > & normal_vector(const unsigned int q_point) const
double shape_value_component(const unsigned int i, const unsigned int q_point, const unsigned int component) const
const unsigned int n_quadrature_points
const FiniteElement< dim, spacedim > & get_fe() const
double JxW(const unsigned int q_point) const
unsigned int n_components() const
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
#define AssertVectorVectorDimension(VEC, DIM1, DIM2)
#define AssertDimension(dim1, dim2)
void nitsche_residual(Vector< double > &result, const FEValuesBase< dim > &fe, const ArrayView< const std::vector< double > > &input, const ArrayView< const std::vector< Tensor< 1, dim > > > &Dinput, const ArrayView< const std::vector< double > > &data, double penalty, double factor=1.)
void nitsche_matrix(FullMatrix< double > &M, const FEValuesBase< dim > &fe, double penalty, double factor=1.)
void cell_matrix(FullMatrix< double > &M, const FEValuesBase< dim > &fe, double factor=1.)
void ip_residual(Vector< double > &result1, Vector< double > &result2, const FEValuesBase< dim > &fe1, const FEValuesBase< dim > &fe2, const ArrayView< const std::vector< double > > &input1, const ArrayView< const std::vector< Tensor< 1, dim > > > &Dinput1, const ArrayView< const std::vector< double > > &input2, const ArrayView< const std::vector< Tensor< 1, dim > > > &Dinput2, double pen, double int_factor=1., double ext_factor=-1.)
void ip_matrix(FullMatrix< double > &M11, FullMatrix< double > &M12, FullMatrix< double > &M21, FullMatrix< double > &M22, const FEValuesBase< dim > &fe1, const FEValuesBase< dim > &fe2, double penalty, double factor1=1., double factor2=-1.)
void cell_residual(Vector< number > &result, const FEValuesBase< dim > &fetest, const ArrayView< const std::vector< Tensor< 1, dim > > > &input, const double factor=1.)
Library of integrals over cells and faces.