]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Prefer StreamType to STREAM.
authorDavid Wells <wellsd2@rpi.edu>
Thu, 12 Nov 2015 20:28:30 +0000 (15:28 -0500)
committerDavid Wells <wellsd2@rpi.edu>
Thu, 12 Nov 2015 20:28:30 +0000 (15:28 -0500)
22 files changed:
include/deal.II/algorithms/any_data.h
include/deal.II/base/index_set.h
include/deal.II/base/path_search.h
include/deal.II/base/polynomial_space.h
include/deal.II/base/timer.h
include/deal.II/fe/fe_update_flags.h
include/deal.II/grid/tria_iterator.h
include/deal.II/lac/block_matrix_array.h
include/deal.II/lac/block_sparse_matrix_ez.h
include/deal.II/lac/full_matrix.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/matrix_free/dof_info.h
include/deal.II/matrix_free/dof_info.templates.h
include/deal.II/matrix_free/helper_functions.h
include/deal.II/matrix_free/mapping_info.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/meshworker/local_results.h
include/deal.II/meshworker/vector_selector.h
source/base/data_out_base.cc

index 7b31146f50b9d7c55c24e9c05ea149f3b7ebf279..b4f9a43fe56e9297f39db36b216c7e7af5be26f3 100644 (file)
@@ -167,8 +167,8 @@ public:
   bool is_type(const unsigned int i) const;
 
   /// List the contents to a stream
-  template <class STREAM>
-  void list (STREAM &os) const;
+  template <class StreamType>
+  void list (StreamType &os) const;
 
   /// An entry with this name does not exist in the AnyData object.
   DeclException1(ExcNameNotFound, std::string,
@@ -448,9 +448,9 @@ AnyData::merge(const AnyData &other)
 }
 
 
-template <class STREAM>
+template <class StreamType>
 inline
-void AnyData::list(STREAM &os) const
+void AnyData::list(StreamType &os) const
 {
   for (unsigned int i=0; i<names.size(); ++i)
     {
index b0dc5a4016fa05a4ad2d81f99cf00eb9d3195eee..821cc494ab90a8462b84808660b8f3aa63a9fbb3 100644 (file)
@@ -302,8 +302,8 @@ public:
    * Outputs a text representation of this IndexSet to the given stream. Used
    * for testing.
    */
-  template <class STREAM>
-  void print(STREAM &out) const;
+  template <class StreamType>
+  void print(StreamType &out) const;
 
   /**
    * Writes the IndexSet into a text based file format, that can be read in
@@ -1563,10 +1563,10 @@ IndexSet::fill_binary_vector (Vector &vector) const
 
 
 
-template <class STREAM>
+template <class StreamType>
 inline
 void
-IndexSet::print (STREAM &out) const
+IndexSet::print (StreamType &out) const
 {
   compress();
   out << "{";
index 7df32ecaf9f8c8022b63a6ceca693aa98b17bed7..94ec30f92512a6500dac4f2037ab5b21634185df 100644 (file)
@@ -149,8 +149,8 @@ public:
   /**
    * Show the paths and suffixes used for this object.
    */
-  template <class STREAM>
-  void show(STREAM &stream) const;
+  template <class StreamType>
+  void show(StreamType &stream) const;
 
   /**
    * Add a new class.
@@ -252,10 +252,10 @@ private:
 /* ----------------------------- inline functions ------------------------- */
 
 
-template <class STREAM>
+template <class StreamType>
 inline
 void
-PathSearch::show(STREAM &out) const
+PathSearch::show(StreamType &out) const
 {
   out << "DEAL_II_" << cls << "PATH=\"";
   bool first = true;
index 8853bf40d86c0e6e6a479db508cfada5c1382a19..6ff52953cab2fefc0c3b7bdeec5692ad26cf72bd 100644 (file)
@@ -116,8 +116,8 @@ public:
   /**
    * Prints the list of the indices to <tt>out</tt>.
    */
-  template <class STREAM>
-  void output_indices(STREAM &out) const;
+  template <class StreamType>
+  void output_indices(StreamType &out) const;
 
   /**
    * Sets the ordering of the polynomials. Requires
@@ -299,9 +299,9 @@ PolynomialSpace<dim>::degree() const
 
 
 template <int dim>
-template <class STREAM>
+template <class StreamType>
 void
-PolynomialSpace<dim>::output_indices(STREAM &out) const
+PolynomialSpace<dim>::output_indices(StreamType &out) const
 {
   unsigned int ix[dim];
   for (unsigned int i=0; i<n_pols; ++i)
index 1bdc54471eec9007e86866581bb7cb338b6ca252..a6529290ebc67ae95d92690aaca0ca0528461ecc 100644 (file)
@@ -109,8 +109,8 @@ public:
   /**
    * Prints the data to the given stream.
    */
-  template <class STREAM>
-  void print_data(STREAM &stream) const;
+  template <class StreamType>
+  void print_data(StreamType &stream) const;
 
 
 #endif
@@ -685,10 +685,10 @@ Timer::get_data() const
 
 
 
-template <class STREAM>
+template <class StreamType>
 inline
 void
-Timer::print_data(STREAM &stream) const
+Timer::print_data(StreamType &stream) const
 {
   unsigned int my_id = dealii::Utilities::MPI::this_mpi_process(mpi_communicator);
   if (my_id==0)
index 52afc20b5c9e256957b5222082a14d31dc6cd90f..84d473ddfffa89c682ecadbe2ec7fb3636cf2cf0 100644 (file)
@@ -243,9 +243,9 @@ enum UpdateFlags
  *
  * @ref UpdateFlags
  */
-template <class STREAM>
+template <class StreamType>
 inline
-STREAM &operator << (STREAM &s, UpdateFlags u)
+StreamType &operator << (StreamType &s, UpdateFlags u)
 {
   s << " UpdateFlags|";
   if (u & update_values)                                  s << "values|";
index 094dc8e54ef9eb78e4cd25f1d526310f1b7885cf..335a7c5416e0206b94ea38cb1faad2c7328db360 100644 (file)
@@ -473,8 +473,8 @@ public:
    * Print the iterator to a stream <code>out</code>. The format is
    * <tt>level.index</tt>.
    */
-  template <class STREAM>
-  void print (STREAM &out) const;
+  template <class StreamType>
+  void print (StreamType &out) const;
 
 
   /**
@@ -1059,10 +1059,10 @@ TriaRawIterator<Accessor>::operator -- ()
 
 
 template <typename Accessor>
-template <class STREAM>
+template <class StreamType>
 inline
 void
-TriaRawIterator<Accessor>::print (STREAM &out) const
+TriaRawIterator<Accessor>::print (StreamType &out) const
 {
   if (Accessor::structure_dimension==Accessor::dimension)
     out << accessor.level() << "." << accessor.index();
index e99c2025f8bedf91a0c7e863759ab2a0b4ffc52c..d60fecda85359b62c58d96748c38150eca29746c 100644 (file)
@@ -252,8 +252,8 @@ public:
    * Nevertheless, the output at least gives some kind of idea of the block
    * structure of this matrix.
    */
-  template <class STREAM>
-  void print_latex (STREAM &out) const;
+  template <class StreamType>
+  void print_latex (StreamType &out) const;
 
 protected:
   /**
@@ -550,10 +550,10 @@ BlockMatrixArray<number, BlockVectorType>::enter (const MatrixType &matrix,
 
 
 template <typename number, typename BlockVectorType>
-template <class STREAM>
+template <class StreamType>
 inline
 void
-BlockMatrixArray<number, BlockVectorType>::print_latex (STREAM &out) const
+BlockMatrixArray<number, BlockVectorType>::print_latex (StreamType &out) const
 {
   out << "\\begin{array}{"
       << std::string(n_block_cols(), 'c')
index 492b9310d161fc399e0103449de1082da487d27a..1ef96a9ed5bb727feb7c2a8e1a3a2d42990bcd3f 100644 (file)
@@ -241,8 +241,8 @@ public:
    * existing row lengths and allocated row lengths. Otherwise, just the
    * relation of allocated and used entries is shown.
    */
-  template <class STREAM>
-  void print_statistics (STREAM &s, bool full = false);
+  template <class StreamType>
+  void print_statistics (StreamType &s, bool full = false);
 
 private:
   /**
@@ -478,10 +478,10 @@ Tvmult_add (BlockVector<somenumber>       &dst,
 
 
 template <typename number>
-template <class STREAM>
+template <class StreamType>
 inline
 void
-BlockSparseMatrixEZ<number>::print_statistics (STREAM &out, bool full)
+BlockSparseMatrixEZ<number>::print_statistics (StreamType &out, bool full)
 {
   size_type used_total = 0;
   size_type allocated_total = 0;
index 0aadc96c7cdcef17f33f1bb202e47f9180e1d165..1d9be2c4dfc0e1bfbd35f723729d2c7ca801eebf 100644 (file)
@@ -566,8 +566,8 @@ public:
    * stream before setting these given values for output, and restores the
    * previous values after output.
    */
-  template <class STREAM>
-  void print (STREAM             &s,
+  template <class StreamType>
+  void print (StreamType         &s,
               const unsigned int  width=5,
               const unsigned int  precision=2) const;
 
@@ -1529,10 +1529,10 @@ FullMatrix<number>::add (const size_type    row,
 
 
 template <typename number>
-template <class STREAM>
+template <class StreamType>
 inline
 void
-FullMatrix<number>::print (STREAM             &s,
+FullMatrix<number>::print (StreamType         &s,
                            const unsigned int  w,
                            const unsigned int  p) const
 {
index ba07c371185da8a53c02c3ffe50c5c12a1851c32..27d868e3c66d4d778152a806f69bb6876538a049 100644 (file)
@@ -1428,10 +1428,10 @@ public:
    * internal storage scheme. If it is false, the elements in a row are
    * written in ascending column order.
    */
-  template <class STREAM>
-  void print (STREAM &out,
-              const bool across = false,
-              const bool diagonal_first = true) const;
+  template <class StreamType>
+  void print (StreamType &out,
+              const bool  across = false,
+              const bool  diagonal_first = true) const;
 
   /**
    * Print the matrix in the usual format, i.e. as a matrix and not as a list
@@ -2340,11 +2340,11 @@ SparseMatrix<number>::end (const size_type r)
 
 
 template <typename number>
-template <class STREAM>
+template <class StreamType>
 inline
-void SparseMatrix<number>::print (STREAM &out,
-                                  const bool across,
-                                  const bool diagonal_first) const
+void SparseMatrix<number>::print (StreamType &out,
+                                  const bool  across,
+                                  const bool  diagonal_first) const
 {
   Assert (cols != 0, ExcNotInitialized());
   Assert (val != 0, ExcNotInitialized());
index b75558a04dfe64fec5749714f1230d397142b89b..153b5a8ede8815719578e4164d8c5d31108071a5 100644 (file)
@@ -406,8 +406,8 @@ public:
    * existing row lengths and allocated row lengths. Otherwise, just the
    * relation of allocated and used entries is shown.
    */
-  template <class STREAM>
-  void print_statistics (STREAM &s, bool full = false);
+  template <class StreamType>
+  void print_statistics (StreamType &s, bool full = false);
 
   /**
    * Compute numbers of entries.
@@ -1558,10 +1558,10 @@ SparseMatrixEZ<number>::conjugate_add (const MatrixTypeA &A,
 
 
 template <typename number>
-template <class STREAM>
+template <class StreamType>
 inline
 void
-SparseMatrixEZ<number>::print_statistics(STREAM &out, bool full)
+SparseMatrixEZ<number>::print_statistics(StreamType &out, bool full)
 {
   size_type used;
   size_type allocated;
index bd306c205b52c28875d02685f4ad5a41a725b78d..49d2599ba27898913c5ad90754ff02fda964e5ea 100644 (file)
@@ -282,8 +282,8 @@ namespace internal
        * Prints a detailed summary of memory consumption in the different
        * structures of this class to the given output stream.
        */
-      template <typename STREAM>
-      void print_memory_consumption(STREAM         &out,
+      template <typename StreamType>
+      void print_memory_consumption(StreamType     &out,
                                     const SizeInfo &size_info) const;
 
       /**
index c57472054b52e2c0908510187bcd1eff5f73b962..33789b3ccf4a77284ca112c90cd0a68fc92dfe4e 100644 (file)
@@ -1933,9 +1933,9 @@ not_connect:
 
 
 
-    template <typename STREAM>
+    template <typename StreamType>
     void
-    DoFInfo::print_memory_consumption (STREAM         &out,
+    DoFInfo::print_memory_consumption (StreamType     &out,
                                        const SizeInfo &size_info) const
     {
       out << "       Memory row starts indices:    ";
index c63776aa643c7aa69e059fdcea0043d795bb7652..f82802747648bbe8a10ef171329a298f826cab17 100644 (file)
@@ -101,8 +101,8 @@ namespace internal
        * Prints minimum, average, and maximal memory consumption over the MPI
        * processes.
        */
-      template <typename STREAM>
-      void print_memory_statistics (STREAM     &out,
+      template <typename StreamType>
+      void print_memory_statistics (StreamType &out,
                                     std::size_t data_length) const;
 
       /**
index 906e2ae6ad8126d2e6f6428ca1816b020e052be9..c47feef7457bcf8ec990f43f943c341f91c45634 100644 (file)
@@ -116,8 +116,8 @@ namespace internal
        * Prints a detailed summary of memory consumption in the different
        * structures of this class to the given output stream.
        */
-      template <typename STREAM>
-      void print_memory_consumption(STREAM         &out,
+      template <typename StreamType>
+      void print_memory_consumption(StreamType     &out,
                                     const SizeInfo &size_info) const;
 
       /**
@@ -274,8 +274,8 @@ namespace internal
          * Prints a detailed summary of memory consumption in the different
          * structures of this class to the given output stream.
          */
-        template <typename STREAM>
-        void print_memory_consumption(STREAM         &out,
+        template <typename StreamType>
+        void print_memory_consumption(StreamType     &out,
                                       const SizeInfo &size_info) const;
 
         /**
index 1c68ab104e133f76d9f8bf0c0fd242a3c7027f48..6e9e0ff8cb4ebefef0b55f122a8b322be6996d15 100644 (file)
@@ -856,9 +856,9 @@ namespace internal
 
 
     template <int dim, typename Number>
-    template <typename STREAM>
+    template <typename StreamType>
     void MappingInfo<dim,Number>::MappingInfoDependent::print_memory_consumption
-    (STREAM         &out,
+    (StreamType     &out,
      const SizeInfo &size_info) const
     {
       // print_memory_statistics involves global communication, so we can
@@ -901,8 +901,8 @@ namespace internal
 
 
     template <int dim, typename Number>
-    template <typename STREAM>
-    void MappingInfo<dim,Number>::print_memory_consumption(STREAM &out,
+    template <typename StreamType>
+    void MappingInfo<dim,Number>::print_memory_consumption(StreamType     &out,
                                                            const SizeInfo &size_info) const
     {
       out << "    Cell types:                      ";
index 4e63fbf8c05c360b6a2271326db149ccbcfa8329..4ef90dd6f6ceacebfc432527c3d82f2851e13af9 100644 (file)
@@ -730,8 +730,8 @@ public:
    * Prints a detailed summary of memory consumption in the different
    * structures of this class to the given output stream.
    */
-  template <typename STREAM>
-  void print_memory_consumption(STREAM &out) const;
+  template <typename StreamType>
+  void print_memory_consumption(StreamType &out) const;
 
   /**
    * Prints a summary of this class to the given output stream. It is focused
index 68b6a8a71d05d67c757a4cb04aa25d0a49d519d2..575fbba5b777af44ef4f145b0f7fc186a792ba73 100644 (file)
@@ -772,8 +772,8 @@ std::size_t MatrixFree<dim,Number>::memory_consumption () const
 
 
 template <int dim, typename Number>
-template <typename STREAM>
-void MatrixFree<dim,Number>::print_memory_consumption (STREAM &out) const
+template <typename StreamType>
+void MatrixFree<dim,Number>::print_memory_consumption (StreamType &out) const
 {
   out << "  Memory cell FE operator total: --> ";
   size_info.print_memory_statistics (out, memory_consumption());
@@ -890,8 +890,8 @@ namespace internal
 
 
 
-    template <typename STREAM>
-    void SizeInfo::print_memory_statistics (STREAM     &out,
+    template <typename StreamType>
+    void SizeInfo::print_memory_statistics (StreamType &out,
                                             std::size_t data_length) const
     {
       Utilities::MPI::MinMaxAvg memory_c
index 637103a1263bd6f753b4cd4e52e320833bb54b3d..d9427c0d9233529ef5881b2804756b8152d86f83 100644 (file)
@@ -349,8 +349,8 @@ namespace MeshWorker
      */
     void reinit(const BlockIndices &local_sizes);
 
-    template <class STREAM>
-    void print_debug(STREAM &os) const;
+    template <class StreamType>
+    void print_debug(StreamType &os) const;
 
     /**
      * The memory used by this object.
@@ -640,9 +640,9 @@ namespace MeshWorker
 
 
   template <typename number>
-  template <class STREAM>
+  template <class StreamType>
   void
-  LocalResults<number>::print_debug(STREAM &os) const
+  LocalResults<number>::print_debug(StreamType &os) const
   {
     os << "J: " << J.size() << std::endl;
     os << "R: " << R.size() << std::endl;
index f4ba7ff549978360265ae3081c959ea6081f8028..0aea12eece09e7ec6c40f0d75085383fc8ef8a1b 100644 (file)
@@ -134,14 +134,14 @@ namespace MeshWorker
     /**
      * Print the contents of the selection to the stream.
      */
-    template <class STREAM, typename DATA>
-    void print (STREAM &s, const AnyData &v) const;
+    template <class StreamType, typename DATA>
+    void print (StreamType &s, const AnyData &v) const;
 
     /**
      * Print the number of selections to the stream.
      */
-    template <class STREAM>
-    void print (STREAM &s) const;
+    template <class StreamType>
+    void print (StreamType &s) const;
 
     /**
      * The memory used by this object.
@@ -496,9 +496,9 @@ namespace MeshWorker
   }
 
 
-  template <class STREAM>
+  template <class StreamType>
   inline void
-  VectorSelector::print(STREAM &s) const
+  VectorSelector::print(StreamType &s) const
   {
     s << "values: " << n_values()
       << " gradients: " << n_gradients()
@@ -507,9 +507,9 @@ namespace MeshWorker
   }
 
 
-  template <class STREAM, typename DATA>
+  template <class StreamType, typename DATA>
   inline void
-  VectorSelector::print(STREAM &s, const AnyData &v) const
+  VectorSelector::print(StreamType &s, const AnyData &v) const
   {
     s << "values:   ";
     for (unsigned int i=0; i<n_values(); ++i)
index b8d2cbd7154f90ab238c08f94961d44cdff5aa68..bbe6a7c2e4cb8210b383c13d5b3fb5a4f99ee429 100644 (file)
@@ -2127,10 +2127,10 @@ namespace DataOutBase
 
 //----------------------------------------------------------------------//
 
-  template <int dim, int spacedim, typename STREAM>
+  template <int dim, int spacedim, typename StreamType>
   void
   write_nodes (const std::vector<Patch<dim,spacedim> > &patches,
-               STREAM &out)
+               StreamType                              &out)
   {
     Assert (dim<=3, ExcNotImplemented());
     unsigned int count = 0;
@@ -2168,10 +2168,10 @@ namespace DataOutBase
     out.flush_points ();
   }
 
-  template <int dim, int spacedim, typename STREAM>
+  template <int dim, int spacedim, typename StreamType>
   void
   write_cells (const std::vector<Patch<dim,spacedim> > &patches,
-               STREAM &out)
+               StreamType                              &out)
   {
     Assert (dim<=3, ExcNotImplemented());
     unsigned int count = 0;
@@ -2210,13 +2210,13 @@ namespace DataOutBase
   }
 
 
-  template <int dim, int spacedim, class STREAM>
+  template <int dim, int spacedim, class StreamType>
   void
-  write_data (
-    const std::vector<Patch<dim,spacedim> > &patches,
-    unsigned int n_data_sets,
-    const bool double_precision,
-    STREAM &out)
+  write_data
+  (const std::vector<Patch<dim,spacedim> > &patches,
+   unsigned int                             n_data_sets,
+   const bool                               double_precision,
+   StreamType                              &out)
   {
     Assert (dim<=3, ExcNotImplemented());
     unsigned int count = 0;

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.