#include <fe/mapping_q.h>
// And this again is C++:
+#include <iostream>
#include <fstream>
#include <cmath>
// following file for its
// declaration:
#include <algorithm>
+#include <iostream>
#include <iomanip>
#include <cmath>
#include <base/timer.h>
// And this again is C++:
+#include <iostream>
#include <fstream>
#include <lac/precondition.h>
// Finally, this is for output to a
- // file.
+ // file and to the console:
#include <numerics/data_out.h>
#include <fstream>
+#include <iostream>
// Instead of the procedural
#include <numerics/data_out.h>
#include <fstream>
+#include <iostream>
// This is new, however: in the
// previous example we got some
#include <fstream>
// ... and this is too: We will
// convert integers to strings using
- // the the C++ stringstream class
- // ``ostringstream''. One slight
+ // the C++ stringstream class
+ // ``ostringstream''. One annoying
// complication arises here in that
// the classes ``std::istringstream''
// and ``std::ostringstream'' (with
// around the time the C++ standard
// was made in 1999. For example, the
// gcc compiler up to and including
- // version 2.95.x did not have them,
+ // version 2.95.2 did not have them,
// but instead provided classes
// ``istrstream'' and ``ostrstream''
// with a similar, but nevertheless
// run time using an input file.
// Finally, we need the filename to
- // which the results is to be
+ // which the results are to be
// written. We would like to have
// it of the form
// ``solution-N.eps'', where N is
- // the number of refinement
+ // the number of the refinement
// cycle. Thus, we have to convert
// an integer to a part of a
// string; this can be done using
// write everything into a special
// stream (just like writing into a
// file or to the screen) and
- // retrieve that as a string. This
- // applies the usual conversions
- // from integer to strings, and one
- // could as well give stream
- // modifiers such as ``setf'',
- // ``setprecision'', and so on.
+ // retrieve what you wrote as a
+ // string. This applies the usual
+ // conversions from integer to
+ // strings, and one could as well
+ // give stream modifiers such as
+ // ``setw'', ``setprecision'', and
+ // so on.
//
// In C++, you can do this by using
// the so-called stringstream
// the two classes which we might
// now be using, depending on which
// one is available, is close
- // enough that we need not take
- // care about the differences any
- // more, so we can use them in a
- // straightforward way, even if
- // they are not identical.
+ // enough that we need to take care
+ // about the differences only once
+ // below, so we can use them in a
+ // rather straightforward way, even
+ // if they are not identical.
// In order to now actually
// generate a filename, we fill the
// We can get whatever we wrote to
// the stream using the ``str()''
- // function. If the new stringstream
- // classes are used, then the result is
- // a string which we have to convert to
- // a char* using the ``c_str()''
- // function, otherwise the result is a
- // char* right away. Use that as filename
- // for the output stream:
+ // function. If the new
+ // stringstream classes are used,
+ // then the result is a string
+ // which we have to convert to a
+ // char* using the ``c_str()''
+ // function, otherwise the result
+ // is a char* right away. Use that
+ // as filename for the output
+ // stream:
#ifdef HAVE_STD_STRINGSTREAM
std::ofstream output (filename.str().c_str());
#else
#include <numerics/error_estimator.h>
#include <fstream>
+#include <iostream>
// The main class is again almost
// slightly more detail below.
#include <typeinfo>
#include <fstream>
+#include <iostream>
// @sect3{Equation data}
// This again is C++:
#include <fstream>
+#include <iostream>
// The main class is, except for its
// This is C++, as we want to write
// some output to disk:
#include <fstream>
+#include <iostream>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/logstream.h>
#include <fstream>
+#include <iostream>
int main()
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/subscriptor.h>
#include <base/smartpointer.h>
#include <base/logstream.h>
+#include <iostream>
class Test : public Subscriptor
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/logstream.h>
#include <lac/vector.h>
#include <fstream>
-
+#include <iostream>
int main ()
{
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/logstream.h>
#include <fstream>
#include <cmath>
+#include <iostream>
// compute the ratio of two measurements and compare to
// the expected value.
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <fe/mapping_q.h>
#include <fstream>
+#include <iostream>
int main ()
ExcNumberMismatch(std::count (selected_dofs.begin(),
selected_dofs.end(),
true),
- pow(cells_per_direction/2+1,dim)));
+ (int)pow(cells_per_direction/2+1,dim)));
}
deallog << "Check 4 (dim=" << dim << ") ok" << std::endl;
};
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/block_sparse_matrix.h>
#include <lac/block_vector.h>
#include <fstream>
+#include <iostream>
#include <algorithm>
#include <lac/block_sparse_matrix.h>
#include <lac/block_vector.h>
#include <fstream>
+#include <iostream>
#include <vector>
#include <list>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/logstream.h>
#include <lac/block_vector.h>
#include <fstream>
+#include <iostream>
#include <vector>
#include <algorithm>
#include <numeric>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <cmath>
#include <fstream>
+#include <iostream>
#include <iomanip>
#include <cstdlib>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001 by the deal.II authors
+// Copyright (C) 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/matrix_out.h>
#include <lac/full_matrix.h>
#include <fstream>
+#include <iostream>
int main ()
{
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <cmath>
#include <fstream>
+#include <iostream>
#include "testmatrix.h"
#include <base/logstream.h>
#include <lac/sparse_matrix.h>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <base/logstream.h>
#include <fstream>
+#include <iostream>
class TransferTest
:
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <cmath>
#include <fstream>
+#include <iostream>
#include <iomanip>
#include "testmatrix.h"
#include <base/logstream.h>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001 by the deal.II authors
+// Copyright (C) 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <cmath>
#include <fstream>
+#include <iostream>
#include <iomanip>
#include <cstdlib>
#include "testmatrix.h"
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001 by the deal.II authors
+// Copyright (C) 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/sparsity_pattern.h>
#include "testmatrix.h"
#include <fstream>
+#include <iostream>
#include <list>
#include <set>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <lac/vector.h>
#include <cmath>
#include <fstream>
+#include <iostream>