]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix failing Sacado tests 7346/head
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sat, 13 Oct 2018 21:53:17 +0000 (23:53 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sun, 14 Oct 2018 13:43:39 +0000 (15:43 +0200)
tests/ad_common_tests/step-44-helper_res_lin_01.h
tests/ad_common_tests/step-44-helper_var_form_01.h
tests/sacado/physics_functions_01_1.cc
tests/sacado/physics_functions_02_1.cc
tests/sacado/physics_functions_03_1.cc

index 5b53d78d78acc6665304ed7ac0266c68cce932e4..c1a6cdb75176e77e037938dd2733791386702032 100644 (file)
 #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>
@@ -483,9 +481,6 @@ namespace Step44
     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);
@@ -609,7 +604,7 @@ namespace Step44
     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;
@@ -699,7 +694,7 @@ namespace Step44
     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,
index 4ce1729ab341b59dcb19ad0d1901e139e45c0331..9a61b5a70253f94492bc47b789a3aec92e8483d8 100644 (file)
 #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>
@@ -572,7 +570,7 @@ namespace Step44
     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;
@@ -662,7 +660,7 @@ namespace Step44
     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,
index eb8044132e9caa04b0af700023dd41c3e4e5f528..70f624dcb90db51e417f6e8d27ebf9efbf49fc3d 100644 (file)
@@ -30,16 +30,16 @@ main()
 
   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();
index d071399260d7b461614a36f9bed9e7e2d88ed15f..6d3218b600328ca991d03f04422ecf8882851fc2 100644 (file)
@@ -30,16 +30,16 @@ main()
 
   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();
index 64ada8f6b4d05745f4dd07d34fba137788907e2c..6873f2daebbbdbb31eab417b31a8c43f52ae4e35 100644 (file)
@@ -30,16 +30,16 @@ main()
 
   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();

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.