From 47074b2694fb4e4a5f13266a0d48d9d031e1832e Mon Sep 17 00:00:00 2001
From: Wolfgang Bangerth <bangerth@math.tamu.edu>
Date: Tue, 10 Feb 2015 18:19:13 -0600
Subject: [PATCH] Add #include <iostream> to a few tutorial programs.

These are the tutorial programs that use std::cout or std::endl, which we need to
get from <iostream> but don't currently. Presumably because we include it transitively,
but for the sake of learning deal.II and C++, this is one more and unnecessary step
to understand. It turns out it also makes Eclipse happier if we do the explicit
#include, as it shows fewer source errors.
---
 examples/step-1/step-1.cc   | 3 ++-
 examples/step-16/step-16.cc | 1 +
 examples/step-21/step-21.cc | 3 ++-
 examples/step-22/step-22.cc | 3 ++-
 examples/step-29/step-29.cc | 1 +
 examples/step-31/step-31.cc | 3 ++-
 examples/step-37/step-37.cc | 1 +
 examples/step-43/step-43.cc | 1 +
 examples/step-45/step-45.cc | 3 ++-
 examples/step-46/step-46.cc | 3 ++-
 examples/step-49/step-49.cc | 3 ++-
 examples/step-5/step-5.cc   | 1 +
 examples/step-50/step-50.cc | 1 +
 examples/step-51/step-51.cc | 3 +++
 examples/step-53/step-53.cc | 3 ++-
 15 files changed, 25 insertions(+), 8 deletions(-)

diff --git a/examples/step-1/step-1.cc b/examples/step-1/step-1.cc
index 6a9bef0fc0..42c437ba8b 100644
--- a/examples/step-1/step-1.cc
+++ b/examples/step-1/step-1.cc
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 1999 - 2014 by the deal.II authors
+ * Copyright (C) 1999 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
@@ -33,6 +33,7 @@
 #include <deal.II/grid/grid_out.h>
 
 // This is needed for C++ output:
+#include <iostream>
 #include <fstream>
 // And this for the declarations of the `sqrt' and `fabs' functions:
 #include <cmath>
diff --git a/examples/step-16/step-16.cc b/examples/step-16/step-16.cc
index 39b4db2fd5..f879864ea5 100644
--- a/examples/step-16/step-16.cc
+++ b/examples/step-16/step-16.cc
@@ -86,6 +86,7 @@
 #include <deal.II/integrators/l2.h>
 
 // This is C++:
+#include <iostream>
 #include <fstream>
 #include <sstream>
 
diff --git a/examples/step-21/step-21.cc b/examples/step-21/step-21.cc
index 96dace18f6..983f712c9d 100644
--- a/examples/step-21/step-21.cc
+++ b/examples/step-21/step-21.cc
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2006 - 2014 by the deal.II authors
+ * Copyright (C) 2006 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
@@ -57,6 +57,7 @@
 #include <deal.II/numerics/matrix_tools.h>
 #include <deal.II/numerics/data_out.h>
 
+#include <iostream>
 #include <fstream>
 #include <sstream>
 
diff --git a/examples/step-22/step-22.cc b/examples/step-22/step-22.cc
index 8e17beba2d..ad80976407 100644
--- a/examples/step-22/step-22.cc
+++ b/examples/step-22/step-22.cc
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2014 by the deal.II authors
+ * Copyright (C) 2008 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
@@ -64,6 +64,7 @@
 #include <deal.II/lac/sparse_ilu.h>
 
 // This is C++:
+#include <iostream>
 #include <fstream>
 #include <sstream>
 
diff --git a/examples/step-29/step-29.cc b/examples/step-29/step-29.cc
index f2af6693df..04371441c6 100644
--- a/examples/step-29/step-29.cc
+++ b/examples/step-29/step-29.cc
@@ -48,6 +48,7 @@
 #include <deal.II/numerics/data_out.h>
 #include <deal.II/numerics/vector_tools.h>
 
+#include <iostream>
 #include <fstream>
 
 // This header file contains the necessary declarations for the
diff --git a/examples/step-31/step-31.cc b/examples/step-31/step-31.cc
index 94a8fe79d5..45b8ccaedf 100644
--- a/examples/step-31/step-31.cc
+++ b/examples/step-31/step-31.cc
@@ -64,8 +64,9 @@
 #include <deal.II/lac/trilinos_block_vector.h>
 #include <deal.II/lac/trilinos_precondition.h>
 
-// Finally, here are two C++ headers that haven't been included yet by one of
+// Finally, here are a few C++ headers that haven't been included yet by one of
 // the aforelisted header files:
+#include <iostream>
 #include <fstream>
 #include <sstream>
 #include <limits>
diff --git a/examples/step-37/step-37.cc b/examples/step-37/step-37.cc
index 0a855161e1..7fab2a4a0a 100644
--- a/examples/step-37/step-37.cc
+++ b/examples/step-37/step-37.cc
@@ -54,6 +54,7 @@
 #include <deal.II/matrix_free/matrix_free.h>
 #include <deal.II/matrix_free/fe_evaluation.h>
 
+#include <iostream>
 #include <fstream>
 #include <sstream>
 
diff --git a/examples/step-43/step-43.cc b/examples/step-43/step-43.cc
index 868ee58659..0dd8b18599 100644
--- a/examples/step-43/step-43.cc
+++ b/examples/step-43/step-43.cc
@@ -65,6 +65,7 @@
 #include <deal.II/lac/trilinos_block_vector.h>
 #include <deal.II/lac/trilinos_precondition.h>
 
+#include <iostream>
 #include <fstream>
 #include <sstream>
 
diff --git a/examples/step-45/step-45.cc b/examples/step-45/step-45.cc
index 22febb2431..d0b80883fa 100644
--- a/examples/step-45/step-45.cc
+++ b/examples/step-45/step-45.cc
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2010 - 2014 by the deal.II authors
+ * Copyright (C) 2010 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
@@ -47,6 +47,7 @@
 #include <deal.II/numerics/data_out.h>
 #include <deal.II/numerics/vector_tools.h>
 
+#include <iostream>
 #include <fstream>
 
 
diff --git a/examples/step-46/step-46.cc b/examples/step-46/step-46.cc
index d5c3e2b137..252a0e7aa0 100644
--- a/examples/step-46/step-46.cc
+++ b/examples/step-46/step-46.cc
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2011 - 2014 by the deal.II authors
+ * Copyright (C) 2011 - 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
@@ -58,6 +58,7 @@
 #include <deal.II/numerics/data_out.h>
 #include <deal.II/numerics/error_estimator.h>
 
+#include <iostream>
 #include <fstream>
 #include <sstream>
 
diff --git a/examples/step-49/step-49.cc b/examples/step-49/step-49.cc
index fb63396cf4..592cafc54c 100644
--- a/examples/step-49/step-49.cc
+++ b/examples/step-49/step-49.cc
@@ -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.
  *
@@ -37,6 +37,7 @@
 #include <deal.II/grid/grid_out.h>
 #include <deal.II/grid/grid_in.h>
 
+#include <iostream>
 #include <fstream>
 
 #include <map>
diff --git a/examples/step-5/step-5.cc b/examples/step-5/step-5.cc
index 058898eac6..f51f193b76 100644
--- a/examples/step-5/step-5.cc
+++ b/examples/step-5/step-5.cc
@@ -53,6 +53,7 @@
 
 // This is C++ ...
 #include <fstream>
+#include <iostream>
 // ... and this is too: We will convert integers to strings using the C++
 // stringstream class <code>ostringstream</code>:
 #include <sstream>
diff --git a/examples/step-50/step-50.cc b/examples/step-50/step-50.cc
index 2352788fa0..de8e2f2ab6 100644
--- a/examples/step-50/step-50.cc
+++ b/examples/step-50/step-50.cc
@@ -102,6 +102,7 @@
 #include <deal.II/multigrid/mg_matrix.h>
 
 // This is C++:
+#include <iostream>
 #include <fstream>
 #include <sstream>
 
diff --git a/examples/step-51/step-51.cc b/examples/step-51/step-51.cc
index 3af72e1dd8..646d49a1e5 100644
--- a/examples/step-51/step-51.cc
+++ b/examples/step-51/step-51.cc
@@ -79,6 +79,9 @@
 // the simulation.
 #include <deal.II/numerics/data_out_faces.h>
 
+#include <iostream>
+
+
 
 // We start by putting the class into its own namespace.
 namespace Step51
diff --git a/examples/step-53/step-53.cc b/examples/step-53/step-53.cc
index 7bccfbb901..2e5822fae7 100644
--- a/examples/step-53/step-53.cc
+++ b/examples/step-53/step-53.cc
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2014 by the deal.II authors
+ * Copyright (C) 2014, 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
@@ -46,6 +46,7 @@
 #include <boost/iostreams/filter/gzip.hpp>
 #include <boost/iostreams/device/file.hpp>
 
+#include <iostream>
 #include <fstream>
 
 
-- 
2.39.5