#include <deal.II/grid/grid_in.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
-#include <deal.II/grid/tria_boundary_lib.h>
#include <deal.II/lac/block_sparse_matrix.h>
#include <deal.II/lac/block_vector.h>
-#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/linear_operator.h>
SymmetricTensor<2, dim, NumberType>
get_tau_bar(const Tensor<2, dim, NumberType> &F) const
{
- using adtl::pow;
- using std::pow;
-
const NumberType det_F = determinant(F);
SymmetricTensor<2, dim, NumberType> b_bar = symmetrize(F * transpose(F));
b_bar *= std::pow(det_F, -2.0 / dim);
const QGauss<dim - 1> qf_face;
const unsigned int n_q_points;
const unsigned int n_q_points_f;
- ConstraintMatrix constraints;
+ AffineConstraints<double> constraints;
BlockSparsityPattern sparsity_pattern;
BlockSparseMatrix<double> tangent_matrix;
BlockVector<double> system_rhs;
make_grid();
system_setup();
{
- ConstraintMatrix constraints;
+ AffineConstraints<double> constraints;
constraints.close();
const ComponentSelectFunction<dim> J_mask(J_component, n_components);
VectorTools::project(dof_handler_ref,
#include <deal.II/grid/grid_in.h>
#include <deal.II/grid/grid_tools.h>
#include <deal.II/grid/tria.h>
-#include <deal.II/grid/tria_boundary_lib.h>
#include <deal.II/lac/block_sparse_matrix.h>
#include <deal.II/lac/block_vector.h>
-#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/linear_operator.h>
const QGauss<dim - 1> qf_face;
const unsigned int n_q_points;
const unsigned int n_q_points_f;
- ConstraintMatrix constraints;
+ AffineConstraints<double> constraints;
BlockSparsityPattern sparsity_pattern;
BlockSparseMatrix<double> tangent_matrix;
BlockVector<double> system_rhs;
make_grid();
system_setup();
{
- ConstraintMatrix constraints;
+ AffineConstraints<double> constraints;
constraints.close();
const ComponentSelectFunction<dim> J_mask(J_component, n_components);
VectorTools::project(dof_handler_ref,
deallog.push("Double");
{
- test_physics<2, double, AD::NumberTypes::adolc_taped>();
- test_physics<3, double, AD::NumberTypes::adolc_taped>();
+ test_physics<2, double, AD::NumberTypes::sacado_dfad>();
+ test_physics<3, double, AD::NumberTypes::sacado_dfad>();
deallog << "OK" << std::endl;
}
deallog.pop();
deallog.push("Float");
{
- test_physics<2, float, AD::NumberTypes::adolc_taped>();
- test_physics<3, float, AD::NumberTypes::adolc_taped>();
+ test_physics<2, float, AD::NumberTypes::sacado_dfad>();
+ test_physics<3, float, AD::NumberTypes::sacado_dfad>();
deallog << "OK" << std::endl;
}
deallog.pop();
deallog.push("Double");
{
- test_physics<2, double, AD::NumberTypes::adolc_taped>();
- test_physics<3, double, AD::NumberTypes::adolc_taped>();
+ test_physics<2, double, AD::NumberTypes::sacado_dfad>();
+ test_physics<3, double, AD::NumberTypes::sacado_dfad>();
deallog << "OK" << std::endl;
}
deallog.pop();
deallog.push("Float");
{
- test_physics<2, float, AD::NumberTypes::adolc_taped>();
- test_physics<3, float, AD::NumberTypes::adolc_taped>();
+ test_physics<2, float, AD::NumberTypes::sacado_dfad>();
+ test_physics<3, float, AD::NumberTypes::sacado_dfad>();
deallog << "OK" << std::endl;
}
deallog.pop();
deallog.push("Double");
{
- test_physics<2, double, AD::NumberTypes::adolc_taped>();
- test_physics<3, double, AD::NumberTypes::adolc_taped>();
+ test_physics<2, double, AD::NumberTypes::sacado_dfad>();
+ test_physics<3, double, AD::NumberTypes::sacado_dfad>();
deallog << "OK" << std::endl;
}
deallog.pop();
deallog.push("Float");
{
- test_physics<2, float, AD::NumberTypes::adolc_taped>();
- test_physics<3, float, AD::NumberTypes::adolc_taped>();
+ test_physics<2, float, AD::NumberTypes::sacado_dfad>();
+ test_physics<3, float, AD::NumberTypes::sacado_dfad>();
deallog << "OK" << std::endl;
}
deallog.pop();