|
Reference documentation for deal.II version 9.2.0
|
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\)
\(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\)
\(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\)
\(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Go to the documentation of this file.
16 #ifndef dealii_integrators_divergence_h
17 #define dealii_integrators_divergence_h
73 const double dx = fe.
JxW(k) * factor;
74 for (
unsigned int i = 0; i < t_dofs; ++i)
77 for (
unsigned int d = 0;
d < dim; ++
d)
78 for (
unsigned int j = 0; j < n_dofs; ++j)
81 M(i, j) +=
dx * du * vv;
99 template <
int dim,
typename number>
104 const double factor = 1.)
114 const double dx = factor * fetest.
JxW(k);
116 for (
unsigned int i = 0; i < t_dofs; ++i)
117 for (
unsigned int d = 0;
d < dim; ++
d)
135 template <
int dim,
typename number>
139 const ArrayView<
const std::vector<double>> &input,
140 const double factor = 1.)
150 const double dx = factor * fetest.
JxW(k);
152 for (
unsigned int i = 0; i < t_dofs; ++i)
153 for (
unsigned int d = 0;
d < dim; ++
d)
186 const double dx = fe.
JxW(k) * factor;
187 for (
unsigned int d = 0;
d < dim; ++
d)
188 for (
unsigned int i = 0; i < t_dofs; ++i)
191 for (
unsigned int j = 0; j < n_dofs; ++j)
194 M(i, j) +=
dx * vv * Du[
d];
212 template <
int dim,
typename number>
217 const double factor = 1.)
227 const double dx = factor * fetest.
JxW(k);
229 for (
unsigned int i = 0; i < t_dofs; ++i)
230 for (
unsigned int d = 0;
d < dim; ++
d)
248 template <
int dim,
typename number>
252 const std::vector<double> &input,
253 const double factor = 1.)
263 const double dx = factor * fetest.
JxW(k);
265 for (
unsigned int i = 0; i < t_dofs; ++i)
266 for (
unsigned int d = 0;
d < dim; ++
d)
298 for (
unsigned int i = 0; i < t_dofs; ++i)
299 for (
unsigned int j = 0; j < n_dofs; ++j)
300 for (
unsigned int d = 0;
d < dim; ++
d)
316 template <
int dim,
typename number>
321 const ArrayView<
const std::vector<double>> &data,
335 for (
unsigned int i = 0; i < t_dofs; ++i)
336 for (
unsigned int d = 0;
d < dim; ++
d)
351 template <
int dim,
typename number>
355 const std::vector<double> &data,
369 for (
unsigned int i = 0; i < t_dofs; ++i)
370 for (
unsigned int d = 0;
d < dim; ++
d)
418 const double dx = factor * fe1.
JxW(k);
419 for (
unsigned int i = 0; i < t_dofs; ++i)
420 for (
unsigned int j = 0; j < n_dofs; ++j)
421 for (
unsigned int d = 0;
d < dim; ++
d)
430 M11(i, j) += .5 *
dx * un1 * v1;
431 M12(i, j) += .5 *
dx * un2 * v1;
432 M21(i, j) += .5 *
dx * un1 * v2;
433 M22(i, j) += .5 *
dx * un2 * v2;
445 const double factor = 1.);
459 template <
int dim,
typename number>
464 const double factor = 1.);
466 template <
int dim,
typename number>
513 const double dx = factor * fe1.
JxW(k);
514 for (
unsigned int i = 0; i < n_dofs; ++i)
515 for (
unsigned int j = 0; j < n_dofs; ++j)
516 for (
unsigned int d = 0;
d < dim; ++
d)
527 M11(i, j) +=
dx * un1 * vn1;
528 M12(i, j) +=
dx * un2 * vn1;
529 M21(i, j) +=
dx * un1 * vn2;
530 M22(i, j) +=
dx * un2 * vn2;
557 double div = Du[0][k][0];
558 for (
unsigned int d = 1;
d < dim; ++
d)
560 result += div * div * fe.
JxW(k);
const double & shape_value(const unsigned int function_no, const unsigned int point_no) const
void grad_div_residual(Vector< number > &result, const FEValuesBase< dim > &fetest, const ArrayView< const std::vector< Tensor< 1, dim >>> &input, const double factor=1.)
void cell_matrix(FullMatrix< double > &M, const FEValuesBase< dim > &fe, const FEValuesBase< dim > &fetest, double factor=1.)
void cell_matrix(FullMatrix< double > &M, const FEValuesBase< dim > &fe, double factor=1.)
void u_dot_n_residual(Vector< number > &result, const FEValuesBase< dim > &fe, const FEValuesBase< dim > &fetest, const ArrayView< const std::vector< double >> &data, double factor=1.)
double shape_value_component(const unsigned int function_no, const unsigned int point_no, const unsigned int component) const
void u_dot_n_matrix(FullMatrix< double > &M, const FEValuesBase< dim > &fe, const FEValuesBase< dim > &fetest, double factor=1.)
const Tensor< 1, spacedim > & normal_vector(const unsigned int i) const
void gradient_matrix(FullMatrix< double > &M, const FEValuesBase< dim > &fe, const FEValuesBase< dim > &fetest, double factor=1.)
void u_dot_n_jump_matrix(FullMatrix< double > &M11, FullMatrix< double > &M12, FullMatrix< double > &M21, FullMatrix< double > &M22, const FEValuesBase< dim > &fe1, const FEValuesBase< dim > &fe2, double factor=1.)
SymmetricTensor< 2, dim, Number > d(const Tensor< 2, dim, Number > &F, const Tensor< 2, dim, Number > &dF_dt)
void u_times_n_residual(Vector< number > &result, const FEValuesBase< dim > &fetest, const std::vector< double > &data, double factor=1.)
void cell_residual(Vector< number > &result, const FEValuesBase< dim > &fetest, const ArrayView< const std::vector< Tensor< 1, dim >>> &input, const double factor=1.)
const unsigned int dofs_per_cell
#define AssertVectorVectorDimension(VEC, DIM1, DIM2)
void grad_div_matrix(FullMatrix< double > &M, const FEValuesBase< dim > &fe, const double factor=1.)
const Tensor< 1, spacedim > & shape_grad(const unsigned int function_no, const unsigned int quadrature_point) const
double norm(const FEValuesBase< dim > &fe, const ArrayView< const std::vector< Tensor< 1, dim >>> &Du)
#define DEAL_II_NAMESPACE_OPEN
Tensor< 1, spacedim > shape_grad_component(const unsigned int function_no, const unsigned int point_no, const unsigned int component) const
#define DEAL_II_DEPRECATED
#define AssertDimension(dim1, dim2)
void cell_residual(Vector< number > &result, const FEValuesBase< dim > &fetest, const ArrayView< const std::vector< Tensor< 1, dim >>> &input, const double factor=1.)
double JxW(const unsigned int quadrature_point) const
Library of integrals over cells and faces.
#define Assert(cond, exc)
const FiniteElement< dim, spacedim > & get_fe() const
static ::ExceptionBase & ExcDimensionMismatch(std::size_t arg1, std::size_t arg2)
void gradient_residual(Vector< number > &result, const FEValuesBase< dim > &fetest, const std::vector< Tensor< 1, dim >> &input, const double factor=1.)
const unsigned int n_quadrature_points
#define DEAL_II_NAMESPACE_CLOSE