const FaceIterator &face2,
const int direction,
const Tensor<1,FaceIterator::AccessorType::space_dimension> &offset
- = Tensor<1,FaceIterator::AccessorType::space_dimension>(),
+ = Tensor<1,FaceIterator::AccessorType::space_dimension>(),
const FullMatrix<double> &matrix = FullMatrix<double>());
const FaceIterator &face2,
const int direction,
const Tensor<2,FaceIterator::AccessorType::space_dimension> &offset
- = Tensor<1,FaceIterator::AccessorType::space_dimension>(),
+ = Tensor<1,FaceIterator::AccessorType::space_dimension>(),
const FullMatrix<double> &matrix = FullMatrix<double>());
{
Assert(face_1->n_active_fe_indices() == 1, ExcInternalError());
const unsigned int n_dofs =
- face_1->get_fe(face_1->nth_active_fe_index(0)).dofs_per_face;
+ face_1->get_fe(face_1->nth_active_fe_index(0)).dofs_per_face;
Assert(matrix.m() == 0 || matrix.m() == n_dofs ||
matrix.m() == (int)spacedim,
{
Assert(face_2->n_active_fe_indices() == 1, ExcInternalError());
const unsigned int n_dofs =
- face_2->get_fe(face_2->nth_active_fe_index(0)).dofs_per_face;
+ face_2->get_fe(face_2->nth_active_fe_index(0)).dofs_per_face;
Assert(matrix.m() == 0 || matrix.m() == n_dofs ||
matrix.m() == (int)spacedim,
if (face_1->has_children() && face_2->has_children())
{
- // In the case that both faces have children, we loop over all
- // children and apply make_periodicty_constrains recursively:
+ // In the case that both faces have children, we loop over all
+ // children and apply make_periodicty_constrains recursively:
- Assert(face_1->n_children() == GeometryInfo<dim>::max_children_per_face &&
- face_2->n_children() ==
- GeometryInfo<dim>::max_children_per_face,
- ExcNotImplemented());
+ Assert(face_1->n_children() == GeometryInfo<dim>::max_children_per_face &&
+ face_2->n_children() ==
+ GeometryInfo<dim>::max_children_per_face,
+ ExcNotImplemented());
- for (unsigned int i = 0; i < GeometryInfo<dim>::max_children_per_face;
- ++i) {
+ for (unsigned int i = 0; i < GeometryInfo<dim>::max_children_per_face;
+ ++i)
+ {
// Lookup the index for the second face
unsigned int j;
switch (dim)
// The finite element that matters is the one on the active face:
const FiniteElement<dim,spacedim> &fe =
- face_1->has_children()
- ? face_2->get_fe(face_2->nth_active_fe_index(0))
- : face_1->get_fe(face_1->nth_active_fe_index(0));
+ face_1->has_children()
+ ? face_2->get_fe(face_2->nth_active_fe_index(0))
+ : face_1->get_fe(face_1->nth_active_fe_index(0));
const unsigned int n_dofs = fe.dofs_per_face;
return;
const FullMatrix<double> transformation =
- compute_transformation(fe, matrix, first_vector_components);
+ compute_transformation(fe, matrix, first_vector_components);
if (! face_2->has_children())
{
component_mask,
face_orientation,
face_orientation
- ? face_rotation ^ face_flip
- : face_flip,
+ ? face_rotation ^ face_flip
+ : face_flip,
face_rotation);
}
}