]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Restore branch to a compilable state. No masks, no hidden compiler warnings.
authoryoung <young@0785d39b-7218-0410-832d-ea1e28bc413d>
Sat, 5 Oct 2013 03:45:53 +0000 (03:45 +0000)
committeryoung <young@0785d39b-7218-0410-832d-ea1e28bc413d>
Sat, 5 Oct 2013 03:45:53 +0000 (03:45 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_petscscalar_complex@31138 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/algorithms/operator.templates.h
deal.II/include/deal.II/lac/block_vector_base.h
deal.II/include/deal.II/lac/constraint_matrix.templates.h
deal.II/include/deal.II/lac/petsc_vector_base.h
deal.II/include/deal.II/numerics/vector_tools.templates.h
deal.II/source/fe/fe_tools_interpolate.cc
deal.II/source/fe/fe_values.cc
deal.II/source/grid/grid_refinement.cc
deal.II/source/numerics/data_out_dof_data.cc
deal.II/source/numerics/matrix_tools.cc
deal.II/source/numerics/point_value_history.cc

index 173d10b9b733de1a6ad25d2a818338018988d5c8..307466f5f742d4fe8b436eca7a829a2c70f97d92 100644 (file)
@@ -72,11 +72,13 @@ namespace Algorithms
       }
     else
       {
-        (*os) << ' ' << step;
-        for (unsigned int i=0; i<vectors.size(); ++i)
-          for (unsigned int j=0; j<vectors(i)->size(); ++j)
-            (*os) << ' ' << (*vectors(i))(j);
-        (*os) << std::endl;
+       /* @whattodo */
+        /* (*os) << ' ' << step; */
+        /* for (unsigned int i=0; i<vectors.size(); ++i) */
+        /*   for (unsigned int j=0; j<vectors(i)->size(); ++j) */
+        /*     (*os) << ' ' << (*vectors(i))(j); */
+        /* (*os) << std::endl; */
+       Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
       }
     return *this;
   }
index 899112340815188fc595d0007dc8c4210b792de8..bad6b91390ba362f2b5662807bbc0f11c50851f2 100644 (file)
@@ -2046,10 +2046,13 @@ typename BlockVectorBase<VectorType>::value_type
 BlockVectorBase<VectorType>::mean_value () const
 {
   value_type sum = 0.;
-  for (size_type i=0; i<n_blocks(); ++i)
-    sum += components[i].mean_value() * components[i].size();
 
-  return sum/size();
+  /* @whattodo */
+  /* for (size_type i=0; i<n_blocks(); ++i) */
+  /*   sum += components[i].mean_value() * components[i].size(); */
+  /* return sum/size(); */
+
+  Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
 }
 
 
@@ -2568,10 +2571,12 @@ void BlockVectorBase<VectorType>::extract_subvector_to (ForwardIterator
                                                         const ForwardIterator    indices_end,
                                                         OutputIterator           values_begin) const
 {
-  while (indices_begin != indices_end) {
-    *values_begin = operator()(*indices_begin);
-    indices_begin++; values_begin++;
-  }
+  /* @whattodo */
+  /*   while (indices_begin != indices_end) { */
+  /*     *values_begin = operator()(*indices_begin); */
+  /*     indices_begin++; values_begin++; */
+  /*   } */
+  Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
 }
 
 #endif // DOXYGEN
index 4a1ce1888cdd58a7a0662e36c3b73026373b4371..28cc4d4a5967919d09ca33148bc0b0516b5c5d60 100644 (file)
@@ -861,7 +861,12 @@ distribute_local_to_global (const Vector<double>            &local_vector,
 
   const size_type n_local_dofs = local_vector.size();
   if (lines.empty())
-    global_vector.add(local_dof_indices, local_vector);
+    {
+      /* @whattodo Note: the Vector and FullMatrix coming in should be
+        complex */
+      /* global_vector.add(local_dof_indices, local_vector); */
+       Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
+    }
   else
     for (size_type i=0; i<n_local_dofs; ++i)
       {
@@ -2243,7 +2248,11 @@ add_this_index:
             // inhomogeneity, we set those to:
             //    inhomogeneity(i)*global_matrix (i,i).
             if (use_inhomogeneities_for_rhs == true)
-              global_vector(global_row) += constraints.get_inhomogeneity(global_row) * new_diagonal;
+             {
+               /* @whattodo */
+               /* global_vector(global_row) += constraints.get_inhomogeneity(global_row) * new_diagonal; */
+               Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
+             }
           }
       }
   }
@@ -2644,7 +2653,11 @@ ConstraintMatrix::distribute_local_to_global (
       Assert (n_values == (size_type)(val_ptr - &vals[0]),
               ExcInternalError());
       if (n_values > 0)
-        global_matrix.add(row, n_values, &cols[0], &vals[0], false, true);
+       {
+         /* @whattodo Note, this is a tricky one! */
+         /* global_matrix.add(row, n_values, &cols[0], &vals[0], false, true); */
+         Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
+       }
     }
 }
 
index 709e1e61859ab34fd4ccce6ded37945cbc72cf53..daff61845a0e5ea5f57d26e407ff9294de54ab99 100644 (file)
@@ -1307,7 +1307,9 @@ namespace PETScWrappers
             && index<static_cast<unsigned int>(end) )
         {
           //local entry
-          *(values_begin+i) = *(ptr+index-begin);
+         /* @whattodo Note: OutputIterator needs to be instantiated as PetscScalar (or std::complex) */
+          /* *(values_begin+i) = *(ptr+index-begin); */
+         Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
         }
         else
         {
@@ -1316,7 +1318,9 @@ namespace PETScWrappers
           = ghost_indices.index_within_set(index);
 
           Assert(ghostidx+end-begin<(unsigned int)lsize, ExcInternalError());
-          *(values_begin+i) = *(ptr+ghostidx+end-begin);
+         /* @whattodo Note: OutputIterator needs to be instantiated as PetscScalar (or std::complex) */
+          /* *(values_begin+i) = *(ptr+ghostidx+end-begin); */
+         Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
         }
       }
 
@@ -1347,8 +1351,10 @@ namespace PETScWrappers
 
         Assert(index>=static_cast<unsigned int>(begin)
             && index<static_cast<unsigned int>(end), ExcInternalError());
-
-        *(values_begin+i) = *(ptr+index-begin);
+       
+       /* @whattodo Note: OutputIterator needs to be instantiated as PetscScalar (or std::complex) */
+       /* *(values_begin+i) = *(ptr+index-begin); */
+       Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
       }
 
       ierr = VecRestoreArray(vector, &ptr);
index 92670d6ac538eff66dd03c26faa2f95f1318122f..17f54d300b0211853c40748a6401e30b149b59cf 100644 (file)
@@ -5594,7 +5594,9 @@ namespace VectorTools
         for (unsigned int i=0; i<n; ++i)
           if (p_select[i])
             {
-              s += v(i);
+             /* @whattodo */
+              /* s += v(i); */
+             Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
               ++counter;
             }
         // Error out if we have not constrained anything. Note that in this
index 8eef0c9e124eb6e95c4b62898729238aaec9dd1f..cd69bd1a0aa6857c15f39009a4c577ad73430280 100644 (file)
@@ -222,7 +222,9 @@ namespace FETools
     for (types::global_dof_index i=0; i<dof2.n_dofs(); ++i)
       if (locally_owned_dofs.is_element(i))
         {
-          Assert(touch_count(i)!=0, ExcInternalError());
+         // @whattodo
+          // Assert(touch_count(i)!=0, ExcInternalError());
+         Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
           u2(i) /= touch_count(i);
         }
 
index a94336f66913db8c52b65fe0787968874e2d57db..a1a471315b23195bb5d4c4d6d2c30145df6713f9 100644 (file)
@@ -44,7 +44,8 @@ namespace
   get_vector_element (const VectorType &vector,
                       const types::global_dof_index cell_number)
   {
-    return vector[cell_number];
+    // @whattodo Note, see another identical whattodo
+    // return vector[cell_number];
   }
 
 
index 1de5c7b1acba704de80b05b2a5f9220773311a61..bfa57d6465b972ac5b083ac84dab89081c7c3ecf 100644 (file)
@@ -69,8 +69,10 @@ namespace
       // to get the array of values from PETSc
       // in every iteration), but works
       PetscScalar m = 0;
-      for (unsigned int i=0; i<criteria.size(); ++i)
-        m = std::max (m, criteria(i));
+      // @whattodo
+      // for (unsigned int i=0; i<criteria.size(); ++i)
+      //   m = std::max (m, criteria(i));
+      Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
       return m;
     }
 
@@ -82,8 +84,10 @@ namespace
       // to get the array of values from PETSc
       // in every iteration), but works
       PetscScalar m = criteria(0);
-      for (unsigned int i=1; i<criteria.size(); ++i)
-        m = std::min (m, criteria(i));
+      // @whattodo
+      // for (unsigned int i=1; i<criteria.size(); ++i)
+      //   m = std::min (m, criteria(i));
+      Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
       return m;
     }
 #endif
index 37ff85b98335784fdd44fc951ade4db04e4a05e2..d510c41b49711b8d1ea291ae1e89d37b827b136d 100644 (file)
@@ -518,7 +518,9 @@ namespace internal
       get_vector_element (const VectorType &vector,
                           const unsigned int cell_number)
       {
-        return vector[cell_number];
+       // @whattodo Note, there should be a way to get the value type from a VectorType
+        // return vector[cell_number];
+       Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
       }
 
 
index af0e940cc8bbdbc591900945156a28f28d586cb4..98421ea0d30f3937e53e711baa463e09a32983c1 100644 (file)
@@ -2420,13 +2420,18 @@ namespace MatrixTools
         // entry from within the part of the
         // matrix that we can see. if we can't
         // find such an entry, take one
-        PetscScalar average_nonzero_diagonal_entry = 1;
-        for (types::global_dof_index i=local_range.first; i<local_range.second; ++i)
-          if (matrix.diag_element(i) != 0)
-            {
-              average_nonzero_diagonal_entry = std::fabs(matrix.diag_element(i));
-              break;
-            }
+
+       // @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)
+        //   if (matrix.diag_element(i) != 0)
+        //     {
+        //       average_nonzero_diagonal_entry = std::fabs(matrix.diag_element(i));
+        //       break;
+        //     }
+       Assert ((false), ExcMessage ("This function is corrupt: @whattodo"));
 
         // figure out which rows of the matrix we
         // have to eliminate on this processor
index c7b849693b6cc991ed42f415b1a79e7fe0ed93d7..53bd353f6d081762312d218bbcb6d040e09e0ca6 100644 (file)
@@ -603,7 +603,12 @@ void PointValueHistory<dim>
           if (mask->second[comp])
             {
               unsigned int solution_index = point->solution_indices[comp];
-              data_store_field->second[data_store_index * n_stored + store_index].push_back (solution (solution_index));
+             //@whattodo
+              (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));
+             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.