]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Wolfgang's patch which fixes tests
authorDenis Davydov <davydden@gmail.com>
Thu, 2 Apr 2015 07:16:46 +0000 (09:16 +0200)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Fri, 8 May 2015 16:23:52 +0000 (11:23 -0500)
tests/fe/function.cc
tests/integrators/divergence_01.cc
tests/integrators/elasticity_01.cc
tests/integrators/laplacian_01.cc
tests/matrix_free/get_functions_common.h

index 4abd6328e1dad487e0d33337f708022519169cac..4a5577fb1abc5f0e436d5ac2f8cfbfdf5ecdf6bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2014 by the deal.II authors
+// Copyright (C) 2013 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -61,8 +61,8 @@ void vector_values(const FiniteElement<dim> &fe)
     v(i) = i;
 
   FEValues<dim> feval(fe, quadrature, update_values);
-  std::vector<Vector<double> > local(quadrature.size(),
-                                     Vector<double>(fe.n_components()));
+  std::vector<Vector<float> > local(quadrature.size(),
+                                   Vector<float>(fe.n_components()));
 
   typename DoFHandler<dim>::active_cell_iterator cell = dof.begin_active();
   const typename DoFHandler<dim>::active_cell_iterator end = dof.end();
index d54a838ea828de591638b5c8d6d64e510b71c910..99f66a8490ed57784e5c98d07bc9ebb18fecebfb 100644 (file)
@@ -30,6 +30,7 @@
 
 using namespace LocalIntegrators::Divergence;
 
+
 template <int dim>
 void test_cell(const FEValuesBase<dim> &fev, const FEValuesBase<dim> &fes)
 {
@@ -63,7 +64,7 @@ void test_cell(const FEValuesBase<dim> &fev, const FEValuesBase<dim> &fes)
       u = 0.;
       u(i) = 1.;
       w = 0.;
-      fev.get_function_gradients(u, indices, ugrad, true);
+      fev.get_function_gradients(u, indices, VectorSlice<std::vector<std::vector<Tensor<1,dim> > > >(ugrad), true);
       cell_residual(w, fes, make_slice(ugrad));
       Md.vmult(v,u);
       w.add(-1., v);
@@ -119,7 +120,7 @@ void test_boundary(const FEValuesBase<dim> &fev, const FEValuesBase<dim> &fes)
       u = 0.;
       u(i) = 1.;
       w = 0.;
-      fev.get_function_values(u, indices, uval, true);
+      fev.get_function_values(u, indices, VectorSlice<std::vector<std::vector<double> > >(uval), true);
       u_dot_n_residual(w, fev, fes, make_slice(uval));
       M.vmult(v,u);
       w.add(-1., v);
index 435222b2a0f072dbcd5d015e7535afdee560f87e..bc4cfaedd5e3aa4271f87961373666a94efe7edd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -58,7 +58,7 @@ void test_cell(const FEValuesBase<dim> &fev)
         u = 0.;
         u(i) = 1.;
         w = 0.;
-        fev.get_function_gradients(u, indices, ugrad, true);
+        fev.get_function_gradients(u, indices, VectorSlice<std::vector<std::vector<Tensor<1,dim> > > >(ugrad), true);
         cell_residual(w, fev, make_slice(ugrad));
         M.vmult(v,u);
         w.add(-1., v);
@@ -99,8 +99,8 @@ void test_boundary(const FEValuesBase<dim> &fev)
         u = 0.;
         u(i) = 1.;
         w = 0.;
-        fev.get_function_values(u, indices, uval, true);
-        fev.get_function_gradients(u, indices, ugrad, true);
+        fev.get_function_values(u, indices, VectorSlice<std::vector<std::vector<double> > >(uval), true);
+        fev.get_function_gradients(u, indices, VectorSlice<std::vector<std::vector<Tensor<1,dim> > > >(ugrad), true);
         nitsche_residual(w, fev, make_slice(uval), make_slice(ugrad), make_slice(null_val), 17);
         M.vmult(v,u);
         w.add(-1., v);
@@ -163,8 +163,8 @@ void test_face(const FEValuesBase<dim> &fev1,
         u1(i1) = 1.;
         w1 = 0.;
         w2 = 0.;
-        fev1.get_function_values(u1, indices1, u1val, true);
-        fev1.get_function_gradients(u1, indices1, u1grad, true);
+        fev1.get_function_values(u1, indices1, VectorSlice<std::vector<std::vector<double> > >(u1val), true);
+        fev1.get_function_gradients(u1, indices1, VectorSlice<std::vector<std::vector<Tensor<1,dim> > > >(u1grad), true);
         ip_residual(w1, w2, fev1, fev2,
                     make_slice(u1val), make_slice(u1grad),
                     make_slice(nullval), make_slice(nullgrad),
@@ -177,8 +177,8 @@ void test_face(const FEValuesBase<dim> &fev1,
 
         w1 = 0.;
         w2 = 0.;
-        fev2.get_function_values(u1, indices2, u1val, true);
-        fev2.get_function_gradients(u1, indices2, u1grad, true);
+        fev2.get_function_values(u1, indices2, VectorSlice<std::vector<std::vector<double> > >(u1val), true);
+        fev2.get_function_gradients(u1, indices2, VectorSlice<std::vector<std::vector<Tensor<1,dim> > > >(u1grad), true);
         ip_residual(w1, w2, fev1, fev2,
                     make_slice(nullval), make_slice(nullgrad),
                     make_slice(u1val), make_slice(u1grad),
index 21334f7120df5e5d9a42972d3321c3ad167eea51..65a272cc4866da22edb2ab2472f0ac5538f780e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2014 by the deal.II authors
+// Copyright (C) 2012 - 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -55,7 +55,7 @@ void test_cell(const FEValuesBase<dim> &fev)
         u = 0.;
         u(i) = 1.;
         w = 0.;
-        fev.get_function_gradients(u, indices, ugrad, true);
+        fev.get_function_gradients(u, indices, VectorSlice<std::vector<std::vector<Tensor<1,dim> > > >(ugrad), true);
         cell_residual(w, fev, make_slice(ugrad));
         M.vmult(v,u);
         w.add(-1., v);
@@ -103,8 +103,8 @@ void test_boundary(const FEValuesBase<dim> &fev)
         u = 0.;
         u(i) = 1.;
         w = 0.;
-        fev.get_function_values(u, indices, uval, true);
-        fev.get_function_gradients(u, indices, ugrad, true);
+        fev.get_function_values(u, indices, VectorSlice<std::vector<std::vector<double> > >(uval), true);
+        fev.get_function_gradients(u, indices, VectorSlice<std::vector<std::vector<Tensor<1,dim> > > >(ugrad), true);
         nitsche_residual(w, fev, make_slice(uval), make_slice(ugrad), make_slice(null_val), 17);
         M.vmult(v,u);
         w.add(-1., v);
@@ -174,8 +174,8 @@ void test_face(const FEValuesBase<dim> &fev1,
         u1(i1) = 1.;
         w1 = 0.;
         w2 = 0.;
-        fev1.get_function_values(u1, indices1, u1val, true);
-        fev1.get_function_gradients(u1, indices1, u1grad, true);
+        fev1.get_function_values(u1, indices1, VectorSlice<std::vector<std::vector<double> > >(u1val), true);
+        fev1.get_function_gradients(u1, indices1, VectorSlice<std::vector<std::vector<Tensor<1,dim> > > >(u1grad), true);
         ip_residual(w1, w2, fev1, fev2,
                     make_slice(u1val), make_slice(u1grad),
                     make_slice(nullval), make_slice(nullgrad),
@@ -200,8 +200,8 @@ void test_face(const FEValuesBase<dim> &fev1,
 
         w1 = 0.;
         w2 = 0.;
-        fev2.get_function_values(u1, indices2, u1val, true);
-        fev2.get_function_gradients(u1, indices2, u1grad, true);
+        fev2.get_function_values(u1, indices2, VectorSlice<std::vector<std::vector<double> > >(u1val), true);
+        fev2.get_function_gradients(u1, indices2, VectorSlice<std::vector<std::vector<Tensor<1,dim> > > >(u1grad), true);
         ip_residual(w1, w2, fev1, fev2,
                     make_slice(nullval), make_slice(nullgrad),
                     make_slice(u1val), make_slice(u1grad),
index 19bf335e4947ab5412b0fb163b372bfca3202a2c..bf0aa20f758fab6553dc1b40bd4bd1ca8536c6fc 100644 (file)
@@ -69,9 +69,9 @@ public:
   {
     FEEvaluation<dim,fe_degree,n_q_points_1d,1,Number> fe_eval (data);
 
-    std::vector<double> reference_values (fe_eval.n_q_points);
-    std::vector<Tensor<1,dim> > reference_grads (fe_eval.n_q_points);
-    std::vector<Tensor<2,dim> > reference_hess (fe_eval.n_q_points);
+    std::vector<Number> reference_values (fe_eval.n_q_points);
+    std::vector<Tensor<1,dim,Number> > reference_grads (fe_eval.n_q_points);
+    std::vector<Tensor<2,dim,Number> > reference_hess (fe_eval.n_q_points);
 
     for (unsigned int cell=cell_range.first; cell<cell_range.second; ++cell)
       {

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.