]> https://gitweb.dealii.org/ - dealii.git/commitdiff
added comments and FIXME
authorDenis Davydov <davydden@gmail.com>
Fri, 3 Apr 2015 06:29:28 +0000 (08:29 +0200)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Fri, 8 May 2015 16:23:53 +0000 (11:23 -0500)
include/deal.II/numerics/vector_tools.templates.h
source/numerics/data_out_dof_data.cc

index c6eab08807b634562fff2ef0535b27991e690fba..05892ca6f0a02ee040a03e00051d0e768a5c2411 100644 (file)
@@ -6407,10 +6407,11 @@ namespace VectorTools
       dealii::hp::FECollection<dim,spacedim> fe_collection (dof.get_fe());
       IDScratchData<dim,spacedim> data(mapping, fe_collection, q, update_flags);
 
-      //FIXME
-      // temporary vectors of consistent with InVector type
+      // FIXME
+      // temporary vectors of consistent with InVector type.
+      // Need these because IDScratchData does not have a template type for the InVector
       std::vector<dealii::Vector<Number>> function_values;
-      std::vector<std::vector<Tensor<1,spacedim,Number> >> function_grads;
+      std::vector<std::vector<Tensor<1,spacedim,Number> > > function_grads;
 
       // loop over all cells
       for (typename DH::active_cell_iterator cell = dof.begin_active();
@@ -7059,6 +7060,11 @@ namespace VectorTools
         p_d_triangulation
         = dynamic_cast<const parallel::distributed::Triangulation<dim,spacedim> *>(&dof.get_tria()))
       {
+        // The type used to store the elements of the global vector may be a
+        // real or a complex number. Do the global reduction always with real
+        // and imaginary types so that we don't have to distinguish, and to this
+        // end just copy everything into a complex number and, later, back into
+        // the original data type.
         std::complex<double> mean_double = mean;
         double my_values[3] = { mean_double.real(), mean_double.imag(), area };
         double global_values[3];
index c232c21c50ed03c46b59d2236d97e3d5df8c035f..dfdb6cf8cfc0d00c3a94c7467c7684b1fcf5256c 100644 (file)
@@ -611,6 +611,7 @@ namespace internal
     get_function_hessians (const FEValuesBase<DH::dimension,DH::space_dimension> &fe_patch_values,
                            std::vector<std::vector<Tensor<2,DH::space_dimension> > >   &patch_hessians_system) const
     {
+      // FIXME
       std::vector<std::vector<Tensor<2,DH::space_dimension,typename VectorType::value_type> > > tmp(patch_hessians_system.size());
       for (unsigned int i = 0; i < tmp.size(); i++)
         tmp[i].resize(patch_hessians_system[i].size());
@@ -628,6 +629,7 @@ namespace internal
     get_function_hessians (const FEValuesBase<DH::dimension,DH::space_dimension> &fe_patch_values,
                            std::vector<Tensor<2,DH::space_dimension> >       &patch_hessians) const
     {
+      // FIXME
       std::vector<Tensor<2,DH::space_dimension,typename VectorType::value_type> > tmp(patch_hessians.size());
       fe_patch_values.get_function_hessians (*vector, tmp);
       for (unsigned int i = 0; i < tmp.size(); i++)

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.