]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Notes.
authoryoung <young@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 22 Oct 2013 22:33:52 +0000 (22:33 +0000)
committeryoung <young@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 22 Oct 2013 22:33:52 +0000 (22:33 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_petscscalar_complex@31394 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/numerics/vector_tools.templates.h
deal.II/source/fe/fe_tools_interpolate.cc
deal.II/source/grid/grid_refinement.cc
deal.II/source/numerics/matrix_tools.cc
deal.II/source/numerics/point_value_history.cc

index 640e7d64761d15dced2241957fe8e1f9ea8ba64f..fbd443823bf879cb4b0578eed6588b4e8e8aa47b 100644 (file)
@@ -303,7 +303,7 @@ namespace VectorTools
     for (; h != endh; ++h, ++l)
       {
        // @whattodo Some of the problems in petsc_vector_base.h are instantiated here.
-       /* h->get_dof_values(data_1, cell_data_1); // <- complaint line 655  */
+       /* h->get_dof_values(data_1, cell_data_1); // <- complaint line 655 */
        Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
 
         transfer.vmult(cell_data_2, cell_data_1);
index 405a8682a2786c14cbab3b35875f8795349b0c81..ce4ea5f3c887e14c8e6f78f64d8e64f174c64004 100644 (file)
@@ -211,7 +211,7 @@ namespace FETools
     // if we work on parallel distributed
     // vectors, we have to ensure, that we only
     // work on dofs this processor owns.
-    IndexSet  locally_owned_dofs = dof2.locally_owned_dofs();
+    IndexSet locally_owned_dofs = dof2.locally_owned_dofs();
 
     // when a discontinuous element is
     // interpolated to a continuous
@@ -222,14 +222,15 @@ namespace FETools
     for (types::global_dof_index i=0; i<dof2.n_dofs(); ++i)
       if (locally_owned_dofs.is_element(i))
         {
-         // @whattodo
-          // Assert(touch_count(i)!=0, ExcInternalError());
+         // @whattodo Workaround: Add a function is_zero like is_finite?
+         // Assert(touch_count(i)!=0, ExcInternalError());
          Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
           u2(i) /= touch_count(i);
         }
 
     // finish the work on parallel vectors
     u2.compress(VectorOperation::insert);
+
     // Apply hanging node constraints.
     constraints.distribute(u2);
   }
index bfa57d6465b972ac5b083ac84dab89081c7c3ecf..ced9477136bd5b0f02487bd319fac851da1ddd5a 100644 (file)
@@ -69,7 +69,7 @@ namespace
       // to get the array of values from PETSc
       // in every iteration), but works
       PetscScalar m = 0;
-      // @whattodo
+      // @whattodo How do we get the maximum element of a complex vector? This only makes sense in real.
       // for (unsigned int i=0; i<criteria.size(); ++i)
       //   m = std::max (m, criteria(i));
       Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
@@ -84,7 +84,7 @@ namespace
       // to get the array of values from PETSc
       // in every iteration), but works
       PetscScalar m = criteria(0);
-      // @whattodo
+      // @whattodo How do we get the minimum element of a complex vector? This only makes sense in real.
       // for (unsigned int i=1; i<criteria.size(); ++i)
       //   m = std::min (m, criteria(i));
       Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
index 5779144510e3814f53ebbb619906ec8721a6929a..68efe162d91639a6457a9ba30292b6e015159a24 100644 (file)
@@ -2372,7 +2372,6 @@ namespace MatrixTools
         // find such an entry, take one
 
        // @whattodo Note: this is a real mess.
-       // Toby: see old notes from Diabelka
         PetscScalar average_nonzero_diagonal_entry;
         // PetscScalar average_nonzero_diagonal_entry = 1;
         // for (types::global_dof_index i=local_range.first; i<local_range.second; ++i)
index 53bd353f6d081762312d218bbcb6d040e09e0ca6..0df772c303ce1652d8217e8a6f234dae8a293da7 100644 (file)
@@ -584,6 +584,7 @@ void PointValueHistory<dim>
   // to check vector_name is in the map.
   typename std::map <std::string, std::vector <std::vector <double> > >::iterator data_store_field = data_store.find(vector_name);
   Assert (data_store_field != data_store.end(), ExcMessage("vector_name not in class"));
+
   // Repeat for component_mask
   typename std::map <std::string, ComponentMask>::iterator mask = component_mask.find(vector_name);
   Assert (mask != component_mask.end(), ExcMessage("vector_name not in class"));
@@ -603,10 +604,11 @@ void PointValueHistory<dim>
           if (mask->second[comp])
             {
               unsigned int solution_index = point->solution_indices[comp];
-             //@whattodo
+             //@whattodo data_store_field shoud be typename VECTOR::value_type, but that cuase problems elsewhere...
               (void) solution_index; // stop g++ complaining: eventually remove this
               (void) n_stored;       // stop g++ complaining: eventually remove this
-              // data_store_field->second[data_store_index * n_stored + store_index].push_back (solution (solution_index));
+    
+             // data_store_field->second[data_store_index * n_stored + store_index].push_back (solution (solution_index));
              Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
 
               store_index++;

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.