if (constraints_are_cyclic)
{
- if (std::abs(cycle_constraint_factor - 1.) > eps)
+ if (std::abs(cycle_constraint_factor - number(1.)) > eps)
affine_constraints.add_line(dof_left);
}
else
// just very small due to roundoff. Of course, constraining x2 in
// terms of x1 has the same problem. So one chooses x1 = b/a*x2 if
// |b|<|a|, and x2 = a/b*x1 if |a|<|b|.
- Assert(
- std::abs(constraint_factor) < 1e10,
- ExcMessage(
- "The periodicity constraint is too large. The parameter periodicity_factor might be too large or too small."));
+ Assert(std::abs(constraint_factor) < 1e10,
+ ExcMessage("The periodicity constraint is too large. "
+ "The parameter periodicity_factor might "
+ "be too large or too small."));
}
} /* for dofs_per_face */
}
//
// ---------------------------------------------------------------------
-for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
+for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS;
+ S : REAL_AND_COMPLEX_SCALARS)
{
#if deal_II_dimension <= deal_II_space_dimension
template void DoFTools::make_periodicity_constraints(
deal_II_space_dimension>::face_iterator &,
const DoFHandler<deal_II_dimension,
deal_II_space_dimension>::face_iterator &,
- AffineConstraints<double> &,
- const ComponentMask &,
- bool,
- bool,
- bool,
- const FullMatrix<double> &,
- const std::vector<unsigned int> &,
- const double);
-
-# ifdef DEAL_II_WITH_COMPLEX_VALUES
- template void DoFTools::make_periodicity_constraints(
- const DoFHandler<deal_II_dimension,
- deal_II_space_dimension>::face_iterator &,
- const DoFHandler<deal_II_dimension,
- deal_II_space_dimension>::face_iterator &,
- AffineConstraints<std::complex<double>> &,
+ AffineConstraints<S> &,
const ComponentMask &,
bool,
bool,
bool,
const FullMatrix<double> &,
const std::vector<unsigned int> &,
- std::complex<double>);
-# endif
+ const S);
#endif
}
-for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS)
+for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension : SPACE_DIMENSIONS;
+ S : REAL_AND_COMPLEX_SCALARS)
{
#if deal_II_dimension <= deal_II_space_dimension
template void
DoFTools::make_periodicity_constraints<deal_II_dimension,
deal_II_space_dimension,
- double>(
- const std::vector<GridTools::PeriodicFacePair<
- DoFHandler<deal_II_dimension, deal_II_space_dimension>::cell_iterator>>
- &,
- AffineConstraints<double> &,
- const ComponentMask &,
- const std::vector<unsigned int> &,
- const double);
-
-# ifdef DEAL_II_WITH_COMPLEX_VALUES
- template void
- DoFTools::make_periodicity_constraints<deal_II_dimension,
- deal_II_space_dimension,
- std::complex<double>>(
+ S>(
const std::vector<GridTools::PeriodicFacePair<
DoFHandler<deal_II_dimension, deal_II_space_dimension>::cell_iterator>>
&,
- AffineConstraints<std::complex<double>> &,
+ AffineConstraints<S> &,
const ComponentMask &,
const std::vector<unsigned int> &,
- const std::complex<double>);
-# endif
-
- template void DoFTools::make_periodicity_constraints(
- const DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
- const types::boundary_id,
- const types::boundary_id,
- const unsigned int,
- AffineConstraints<double> &,
- const ComponentMask &,
- const double);
+ const S);
-# ifdef DEAL_II_WITH_COMPLEX_VALUES
template void DoFTools::make_periodicity_constraints(
const DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
const types::boundary_id,
const types::boundary_id,
const unsigned int,
- AffineConstraints<std::complex<double>> &,
- const ComponentMask &,
- const std::complex<double>);
-# endif
-
- template void DoFTools::make_periodicity_constraints(
- const DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
- const types::boundary_id,
- const unsigned int,
- AffineConstraints<double> &,
+ AffineConstraints<S> &,
const ComponentMask &,
- const double);
+ const S);
-# ifdef DEAL_II_WITH_COMPLEX_VALUES
template void DoFTools::make_periodicity_constraints(
const DoFHandler<deal_II_dimension, deal_II_space_dimension> &,
const types::boundary_id,
const unsigned int,
- AffineConstraints<std::complex<double>> &,
+ AffineConstraints<S> &,
const ComponentMask &,
- const std::complex<double>);
-# endif
+ const S);
#endif
}