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.
/* ---------------------------------------------------------------------
*
- * 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.
*
#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>
#include <deal.II/integrators/l2.h>
// This is C++:
+#include <iostream>
#include <fstream>
#include <sstream>
/* ---------------------------------------------------------------------
*
- * 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.
*
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/data_out.h>
+#include <iostream>
#include <fstream>
#include <sstream>
/* ---------------------------------------------------------------------
*
- * 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.
*
#include <deal.II/lac/sparse_ilu.h>
// This is C++:
+#include <iostream>
#include <fstream>
#include <sstream>
#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
#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>
#include <deal.II/matrix_free/matrix_free.h>
#include <deal.II/matrix_free/fe_evaluation.h>
+#include <iostream>
#include <fstream>
#include <sstream>
#include <deal.II/lac/trilinos_block_vector.h>
#include <deal.II/lac/trilinos_precondition.h>
+#include <iostream>
#include <fstream>
#include <sstream>
/* ---------------------------------------------------------------------
*
- * 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.
*
#include <deal.II/numerics/data_out.h>
#include <deal.II/numerics/vector_tools.h>
+#include <iostream>
#include <fstream>
/* ---------------------------------------------------------------------
*
- * 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.
*
#include <deal.II/numerics/data_out.h>
#include <deal.II/numerics/error_estimator.h>
+#include <iostream>
#include <fstream>
#include <sstream>
/* ---------------------------------------------------------------------
*
- * 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.
*
#include <deal.II/grid/grid_out.h>
#include <deal.II/grid/grid_in.h>
+#include <iostream>
#include <fstream>
#include <map>
// 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>
#include <deal.II/multigrid/mg_matrix.h>
// This is C++:
+#include <iostream>
#include <fstream>
#include <sstream>
// the simulation.
#include <deal.II/numerics/data_out_faces.h>
+#include <iostream>
+
+
// We start by putting the class into its own namespace.
namespace Step51
/* ---------------------------------------------------------------------
*
- * 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.
*
#include <boost/iostreams/filter/gzip.hpp>
#include <boost/iostreams/device/file.hpp>
+#include <iostream>
#include <fstream>