int main ()
{
std::ofstream logfile("block_matrices/output");
- logfile.precision(2);
+ deallog << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
Assert (solutions[i].size() == solutions[i].size(),
ExcInternalError());
- logfile.precision(16);
+ deallog << std::setprecision(16);
for (unsigned int i=1; i<n_datasets; ++i)
{
// relative accuracy. data set
int main ()
{
std::ofstream logfile ("boundaries/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2005, 2006, 2007 by the deal.II authors
+// Copyright (C) 2005, 2006, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
int main ()
{
std::ofstream logfile("constraint_graph/output");
- logfile.precision(2);
-
+ logfile << std::setprecision(2);
+ deallog << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
- logfile.precision (2);
+ deallog << std::setprecision (2);
+ logfile << std::setprecision (2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
std::ofstream logfile ("create_laplace_matrix_01/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("create_laplace_matrix_02/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("create_laplace_matrix_03/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("create_laplace_matrix_04/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("create_mass_matrix_01/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("create_mass_matrix_02/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("create_mass_matrix_03/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("create_mass_matrix_04/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2007 by the deal.II authors
+// Copyright (C) 2000, 2001, 2002, 2003, 2004, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
int main ()
{
deallog.depth_console (0);
- logfile.precision(2);
+ logfile << std::setprecision(2);
+ deallog << std::setprecision(2);
LaplaceProblem<2> laplace_problem_2d;
laplace_problem_2d.run ();
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2004 by the deal.II authors
+// Copyright (C) 2000, 2001, 2004, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
int main ()
{
std::ofstream logfile ("derivative_approximation/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
#include <fe/mapping_q1.h>
#include <fe/fe_values.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <vector>
using namespace std;
int main ()
{
std::ofstream logfile ("derivatives/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
if (!errors) deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
std::ofstream logfile ("dof_renumbering/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2003, 2004, 2007 by the deal.II authors
+// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
int main ()
{
std::ofstream logfile ("dof_renumbering_02/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("error_estimator/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2002, 2003, 2004, 2005, 2008 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 <iomanip>
std::ofstream logfile("face_orientations_3d/output");
int main ()
{
- logfile.precision (2);
+ deallog << std::setprecision (2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
- logfile.precision(4);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision(4);
+ deallog << std::fixed;
deallog.push("GeometryInfo");
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <grid/filtered_iterator.h>
#include <fstream>
+#include <iomanip>
#include <algorithm>
#include <numeric>
#include <cmath>
int main ()
{
- logfile.precision(4);
+ deallog << std::setprecision(4);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
std::ofstream logfile ("filtered_matrix/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2007 by the deal.II authors
+// Copyright (C) 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <fstream>
#include <iostream>
+#include <iomanip>
std::ofstream logfile("grid_generator_01/output");
// $Id$
// Version: $Name$
//
-// Copyright (C) 2007 by the deal.II authors
+// Copyright (C) 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <fstream>
#include <iostream>
+#include <iomanip>
std::ofstream logfile("grid_hyper_shell/output");
// $Id$
// Version: $Name$
//
-// Copyright (C) 2002, 2003, 2004, 2005, 2007 by the deal.II authors
+// Copyright (C) 2002, 2003, 2004, 2005, 2007, 2008 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 <iomanip>
#include <string>
std::ofstream logfile("grid_in/output");
int main ()
{
- logfile.precision (2);
+ deallog << std::setprecision (2);
+ logfile << std::setprecision (2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2002, 2003, 2004, 2005, 2008 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 <iomanip>
std::ofstream logfile("grid_in_3d/output");
int main ()
{
- logfile.precision (2);
+ deallog << std::setprecision (2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+// Copyright (C) 2002, 2003, 2004, 2005, 2006, 2008 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 <iomanip>
#include <string>
std::ofstream logfile("grid_in_msh/output");
int main ()
{
- logfile.precision (2);
+ deallog << std::setprecision (2);
+ logfile << std::setprecision (2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2002, 2003, 2004, 2005, 2007 by the deal.II authors
+// Copyright (C) 2002, 2003, 2004, 2005, 2007, 2008 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 <iomanip>
#include <string>
std::ofstream logfile("grid_in_tecplot/output");
// $Id$
// Version: $Name$
//
-// Copyright (C) 2002, 2003, 2004, 2005, 2007 by the deal.II authors
+// Copyright (C) 2002, 2003, 2004, 2005, 2007, 2008 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 <iomanip>
std::ofstream logfile("grid_out/output");
int main ()
{
- logfile.precision (2);
+ deallog << std::setprecision (2);
+ logfile << std::setprecision (2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2002, 2003, 2004, 2005 by the deal.II authors
+// Copyright (C) 2002, 2003, 2004, 2005, 2008 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 <iomanip>
std::ofstream logfile("grid_out_02/output");
int main ()
{
- logfile.precision (2);
+ deallog << std::setprecision (2);
+ logfile << std::setprecision (2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <grid/grid_in.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
template<int dim>
// $Id$
// Version: $Name$
//
-// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2007 by the deal.II authors
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <cstdlib>
#include <fstream>
+#include <iomanip>
#include <cstdio>
std::ofstream logfile("grid_test/output");
int main ()
{
- logfile.precision(2);
+ deallog << std::setprecision(2);
+ logfile << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <grid/grid_out.h>
#include <fstream>
-
+#include <iomanip>
std::ofstream logfile("grid_tools/output");
int main ()
{
- logfile.precision(4);
+ deallog << std::setprecision(4);
+ logfile << std::setprecision(4);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <fe/mapping_q.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
int main ()
#include <grid/grid_out.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
int main ()
int main ()
{
- logfile.precision(2);
-
+ deallog << std::setprecision(2);
+ logfile << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
std::ofstream logfile("intergrid_map/output");
- logfile.precision(2);
+ deallog << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
#include <fe/fe_raviart_thomas.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <vector>
int main ()
{
std::ofstream logfile("interpolate_dgq_01/output");
- logfile.precision (3);
+ deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
std::ofstream logfile("interpolate_dgq_02/output");
- logfile.precision (3);
+ deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
std::ofstream logfile("interpolate_q_01/output");
- logfile.precision (3);
+ deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
std::ofstream logfile("interpolate_q_02/output");
- logfile.precision (3);
+ deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
std::ofstream logfile("interpolate_q_system_01/output");
- logfile.precision (3);
+ deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
std::ofstream logfile("interpolate_q_system_02/output");
- logfile.precision (3);
+ deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.depth_console(0);
#include <grid/grid_out.h>
#include <fstream>
-#include <iostream>
+#include <iomanip>
#include <iomanip>
// $Id$
// Version: $Name$
//
-// Copyright (C) 2000, 2001, 2003, 2004, 2007 by the deal.II authors
+// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
int main ()
{
std::ofstream logfile ("matrices/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ logfile << std::setprecision (2);
+ logfile << std::fixed;
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <grid/grid_out.h>
#include <fstream>
+#include <iomanip>
std::ofstream logfile("maximal_cell_diameter/output");
int main ()
{
- logfile.precision(4);
+ deallog << std::setprecision(4);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
-// Copyright (C) 2005, 2006 by the deal.II authors
+// Copyright (C) 2005, 2006, 2008 by the deal.II authors
//
// Computes measure, center and barycenter on a variety of cells
#include <grid/tria_accessor.h>
#include <grid/grid_generator.h>
#include <fstream>
+#include <iomanip>
#define PRECISION 5
int main()
{
std::ofstream logfile ("measure_et_al/output");
- logfile.precision (PRECISION);
+ deallog << std::setprecision (PRECISION);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
std::ofstream logfile("mg_dof_handler/output");
- logfile.precision(2);
+ deallog << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006 by the deal.II authors
+// Copyright (C) 2001, 2002, 2003, 2004, 2005, 2006, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <grid/grid_out.h>
#include <fstream>
+#include <iomanip>
std::ofstream logfile("minimal_cell_diameter/output");
int main ()
{
- logfile.precision(4);
+ deallog << std::setprecision(4);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2005 by the deal.II authors
+// Copyright (C) 2005, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <grid/grid_generator.h>
#include <fstream>
+#include <iomanip>
int main ()
{
std::ofstream logfile ("normals_at_vertices/output");
- logfile.precision (3);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (3);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main()
{
std::ofstream logfile ("project_boundary_rt_01/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
deallog.threshold_double(1.e-12);
int main ()
{
std::ofstream logfile(logname);
- logfile.precision (3);
+ deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
std::ofstream logfile ("sparsity_pattern/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("sparsity_pattern_01/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("sparsity_pattern_01_x/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("sparsity_pattern_02/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("sparsity_pattern_03/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("sparsity_pattern_04/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("sparsity_pattern_05/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("sparsity_pattern_05_x/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("sparsity_pattern_x/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
- logfile.precision(4);
+ deallog << std::setprecision(4);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
std::ofstream logfile ("support_point_map/output");
- logfile.precision (2);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006 by the deal.II authors
+// Copyright (C) 2006, 2008 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <cstdlib>
#include <fstream>
+#include <iomanip>
#include <cstdio>
std::ofstream logfile("union_triangulation/output");
int main ()
{
- logfile.precision(2);
+ deallog << std::setprecision(2);
+ logfile << std::setprecision(2);
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
std::ofstream logfile ("vectors_boundary_rhs_01/output");
- logfile.precision (4);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (4);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("vectors_boundary_rhs_02/output");
- logfile.precision (4);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (4);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("vectors_boundary_rhs_03/output");
- logfile.precision (4);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (4);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("vectors_point_source_01/output");
- logfile.precision (4);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (4);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("vectors_rhs_01/output");
- logfile.precision (4);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (4);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);
int main ()
{
std::ofstream logfile ("vectors_rhs_03/output");
- logfile.precision (4);
- logfile.setf(std::ios::fixed);
+ deallog << std::setprecision (4);
+ deallog << std::fixed;
deallog.attach(logfile);
deallog.depth_console (0);