int main ()
{
- initlog(__FILE__, true);
+ initlog();
deallog.depth_console(0);
Triangulation<2> t2;
int main ()
{
- initlog(__FILE__, true);
+ initlog();
deallog.depth_console(0);
Triangulation<2> t2;
int main ()
{
- initlog(__FILE__);
+ initlog();
FE_Q<2> q21(1);
FE_Q<2> q22(2);
int main ()
{
- initlog(__FILE__);
+ initlog();
FE_Q<2> q21(1);
FE_Q<2> q22(2);
int main()
{
- initlog(__FILE__);
+ initlog();
deallog.push("2D");
test_global_refinement<2>(&test_block_list<2>);
deallog.pop();
int main()
{
- initlog(__FILE__);
+ initlog();
deallog.push("2D");
test_global_refinement<2>(&test_block_list<2>);
deallog.pop();
int main()
{
- initlog(__FILE__);
+ initlog();
deallog.push("2D");
test_global_refinement<2>(&test_block_list<2>);
deallog.pop();
int main()
{
- initlog(__FILE__);
+ initlog();
deallog.push("2D");
test_global_refinement<2>(&test_block_list<2>);
deallog.pop();
int main ()
{
- std::ofstream logfile("block_matrices/output");
+ std::ofstream logfile("output");
deallog << std::setprecision(2);
deallog.attach(logfile);
int main ()
{
- initlog(__FILE__);
+ initlog();
deallog << std::setprecision (2);
deallog << std::fixed;
int main()
{
- initlog(__FILE__);
+ initlog();
deallog << std::setprecision (4);
deallog.threshold_double(1.e-7);
int main()
{
- initlog(__FILE__);
+ initlog();
deallog << std::setprecision (4);
deallog.threshold_double(1.e-7);
int main()
{
- initlog(__FILE__);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("2d");
int main()
{
- initlog(__FILE__);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("1d");
int main()
{
- initlog(__FILE__);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("1d");
int main ()
{
- initlog(__FILE__);
+ initlog();
deallogfile << std::setprecision(2);
deallog.threshold_double(1.e-10);
#include <cstdlib>
-std::ofstream logfile("constraints/output");
+std::ofstream logfile("output");
void make_tria (Triangulation<3> &tria, int step)
#include <cstdlib>
-std::ofstream logfile("constraints_block_01/output");
+std::ofstream logfile("output");
int main ()
#include <iostream>
#include <complex>
-std::ofstream logfile("constraints_hanging_nodes_bc/output");
+std::ofstream logfile("output");
template <int dim>
#include <iostream>
#include <complex>
-std::ofstream logfile("constraints_local_to_global/output");
+std::ofstream logfile("output");
template <int dim>
void test ()
#include <iostream>
#include <complex>
-std::ofstream logfile("constraints_local_to_global_chunk/output");
+std::ofstream logfile("output");
template <int dim>
void test (unsigned int chunk_size)
#include <iomanip>
-std::ofstream logfile("constraints_merge/output");
+std::ofstream logfile("output");
void merge_check ()
#include <iomanip>
-std::ofstream logfile("constraints_merge_02/output");
+std::ofstream logfile("output");
void merge_check ()
#include <iomanip>
-std::ofstream logfile("constraints_merge_03/output");
+std::ofstream logfile("output");
void merge_check ()
#include <iomanip>
-std::ofstream logfile("constraints_merge_04/output");
+std::ofstream logfile("output");
void merge_check ()
#include <iomanip>
-std::ofstream logfile("constraints_merge_05/output");
+std::ofstream logfile("output");
void merge_check ()
#include <iomanip>
-std::ofstream logfile("constraints_merge_06/output");
+std::ofstream logfile("output");
void merge_check ()
#include <iomanip>
-std::ofstream logfile("constraints_merge_07/output");
+std::ofstream logfile("output");
void merge_check ()
#include <iomanip>
-std::ofstream logfile("constraints_merge_08/output");
+std::ofstream logfile("output");
void merge_check ()
#include <iomanip>
-std::ofstream logfile("constraints_merge_09/output");
+std::ofstream logfile("output");
void merge_check ()
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_01b/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_02b/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_03b/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_04b/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_constraints_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.threshold_double(1e-10);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_constraints_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.threshold_double(1e-10);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_constraints_02b/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.threshold_double(1e-10);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_constraints_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.threshold_double(1e-10);
int main ()
{
- std::ofstream logfile ("create_laplace_matrix_constraints_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.threshold_double(1e-10);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_01b/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_02b/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_03b/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_04b/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_05/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_constraints_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.threshold_double(1e-10);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_constraints_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.threshold_double(1e-10);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_constraints_02b/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.threshold_double(1e-10);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_constraints_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.threshold_double(1e-10);
int main ()
{
- std::ofstream logfile ("create_mass_matrix_constraints_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
deallog.threshold_double(1e-10);
int main ()
{
- std::ofstream logfile ("create_point_source/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("create_point_source_hp/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
#include <deal.II/base/logstream.h>
-std::ofstream logfile("data_out/output");
+std::ofstream logfile("output");
template <int dim>
#include <deal.II/base/logstream.h>
-std::ofstream logfile("data_out_postprocessor_01/output");
+std::ofstream logfile("output");
template <int dim>
#include <deal.II/base/logstream.h>
-std::ofstream logfile("data_out_postprocessor_scalar_01/output");
+std::ofstream logfile("output");
template <int dim>
#include <deal.II/base/logstream.h>
-std::ofstream logfile("data_out_postprocessor_vector_01/output");
+std::ofstream logfile("output");
template <int dim>
int main ()
{
- std::ofstream logfile ("derivative_approximation/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile("derivative_approximation_2/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile ("derivatives/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
#include <fstream>
#include <iomanip>
-std::ofstream logfile("distort_random/output");
+std::ofstream logfile("output");
int main ()
{
- std::ofstream logfile("dof_accessor_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main()
{
- std::ofstream logfile("dof_handler_number_cache/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main()
{
- initlog(__FILE__);
+ initlog();
deallog.threshold_double(1.e-10);
deallog.push("1d");
int main ()
{
- std::ofstream logfile ("dof_renumbering/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("dof_renumbering_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("dof_renumbering_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("dof_renumbering_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("dof_renumbering_04a/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("dof_renumbering_05/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("dof_renumbering_06/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("dof_renumbering_07/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("dof_renumbering_zorder_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("dof_renumbering_zorder_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
// 2: refinement of the circle at the boundary
// 2: refinement of a wiggled area at the boundary
-std::ofstream logfile("dof_test/output");
+std::ofstream logfile("output");
template <int dim>
int main ()
{
- std::ofstream logfile ("error_estimator/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("error_estimator_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("extent_in_direction/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (PRECISION);
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_01_hp/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_01_mg/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_01x/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_01y/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_02_hp/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_02_mg/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_05/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_05_hp/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_06/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("extract_dofs_by_component_06_hp/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
#include <iomanip>
-std::ofstream logfile("face_orientations_3d/output");
+std::ofstream logfile("output");
void test (const char *filename)
int main ()
{
- initlog(__FILE__);
+ initlog();
deallog << std::setprecision (2);
deallog << std::fixed;
int main()
{
- std::ofstream logfile ("fe_values_extractor_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_05/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_06/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_07/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_08/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_09/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_10/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_10_single_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_10_single_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_10_single_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_10_single_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_11/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_12/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_13/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_14/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_15/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_16/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_17/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_18/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_19/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_20/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_21/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_21_nonsymmetric/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_22/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_23/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_23_nonsymmetric/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_24/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_24_nonsymmetric/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_25/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_25_nonsymmetric/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile ("fe_values_view_invalid_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile ("fe_values_view_invalid_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile ("fe_values_view_invalid_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile ("fe_values_view_invalid_03_nonsymmetric/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("fe_values_view_tensor_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
#include <cmath>
-std::ofstream logfile("filtered_iterator/output");
+std::ofstream logfile("output");
DeclException2 (ExcNumberMismatch,
#include <cmath>
-std::ofstream logfile("filtered_iterator_02/output");
+std::ofstream logfile("output");
DeclException2 (ExcNumberMismatch,
#include <cmath>
-std::ofstream logfile("filtered_iterator_03/output");
+std::ofstream logfile("output");
DeclException2 (ExcNumberMismatch,
int main ()
{
- std::ofstream logfile ("filtered_matrix/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("get_finest_common_cells_01/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile ("get_finest_common_cells_02/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile ("get_finest_common_cells_03/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile ("get_finest_common_cells_04/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <iostream>
#include <iomanip>
-std::ofstream logfile("grid_generator_01/output");
+std::ofstream logfile("output");
template<int dim>
#include <iostream>
#include <iomanip>
-std::ofstream logfile("grid_hyper_shell/output");
+std::ofstream logfile("output");
template<int dim>
#include <iostream>
#include <iomanip>
-std::ofstream logfile("grid_hyper_shell_02/output");
+std::ofstream logfile("output");
template<int dim>
#include <iostream>
#include <iomanip>
-std::ofstream logfile("grid_hyper_shell_03/output");
+std::ofstream logfile("output");
template<int dim>
#include <iostream>
#include <iomanip>
-std::ofstream logfile("grid_hyper_shell_04/output");
+std::ofstream logfile("output");
template<int dim>
#include <iostream>
#include <iomanip>
-std::ofstream logfile("grid_hyper_shell_05/output");
+std::ofstream logfile("output");
template<int dim>
#include <iomanip>
#include <string>
-std::ofstream logfile("grid_in/output");
+std::ofstream logfile("output");
template <int dim>
Triangulation<dim> tria;
GridIn<dim> gi;
gi.attach_triangulation (tria);
- std::ifstream in ("grid_in/2d.inp");
+ std::ifstream in ("2d.inp");
gi.read_ucd (in);
GridOut grid_out;
Triangulation<dim> tria (Triangulation<dim>::none, true);
GridIn<dim> gi;
gi.attach_triangulation (tria);
- std::ifstream in ("grid_in/2d.xda");
+ std::ifstream in ("2d.xda");
try
{
gi.read_xda (in);
Triangulation<dim> tria;
GridIn<dim> gi;
gi.attach_triangulation (tria);
- gi.read ("grid_in/2d.nc");
+ gi.read ("2d.nc");
GridOut grid_out;
std::ofstream gnufile("grid_in_2d.gnuplot");
void filename_resolution()
{
- check_file<2> (std::string("grid_in/2d"), GridIn<2>::ucd);
- check_file<2> (std::string("grid_in/2d"), GridIn<2>::xda);
+ check_file<2> (std::string("2d"), GridIn<2>::ucd);
+ check_file<2> (std::string("2d"), GridIn<2>::xda);
}
#include <iomanip>
#include <string>
-std::ofstream logfile("grid_in_02/output");
+std::ofstream logfile("output");
template <int dim>
Triangulation<dim> tria (Triangulation<dim>::none, true);
GridIn<dim> gi;
gi.attach_triangulation (tria);
- std::ifstream in ("grid_in_02/2d.xda");
+ std::ifstream in ("2d.xda");
try
{
gi.read_xda (in);
#include <fstream>
#include <iomanip>
-std::ofstream logfile("grid_in_3d/output");
+std::ofstream logfile("output");
void test (const char *filename)
Triangulation<3> tria;
GridIn<3> gi;
gi.attach_triangulation (tria);
- gi.read ("grid_in_3d/1.nc");
+ gi.read ("1.nc");
GridOut grid_out;
std::ofstream gnufile("square.gnuplot");
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
- test ("grid_in_3d/1.in");
- test ("grid_in_3d/2.in");
- test ("grid_in_3d/3.in");
- test ("grid_in_3d/4.in");
+ test ("1.in");
+ test ("2.in");
+ test ("3.in");
+ test ("4.in");
- test ("grid_in_3d/evil_0.in");
- test ("grid_in_3d/evil_1.in");
- test ("grid_in_3d/evil_2.in");
- test ("grid_in_3d/evil_3.in");
- test ("grid_in_3d/evil_4.in");
+ test ("evil_0.in");
+ test ("evil_1.in");
+ test ("evil_2.in");
+ test ("evil_3.in");
+ test ("evil_4.in");
// test1 needs NetCDF
// test1 ();
#include <fstream>
#include <iomanip>
-std::ofstream logfile("grid_in_3d_02/output");
+std::ofstream logfile("output");
void test (const char *filename)
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
- test ("grid_in_3d_02/747.ucd");
+ test ("747.ucd");
}
#include <iomanip>
#include <string>
-std::ofstream logfile("grid_in_msh/output");
+std::ofstream logfile("output");
template<int dim>
void filename_resolution()
{
- check_file<2> (std::string("grid_in_msh/mesh"), GridIn<2>::msh);
+ check_file<2> (std::string("mesh"), GridIn<2>::msh);
}
#include <iomanip>
#include <string>
-std::ofstream logfile("grid_in_msh_02/output");
+std::ofstream logfile("output");
template<int dim>
void filename_resolution()
{
- check_file<2> (std::string("grid_in_msh_02/mesh"), GridIn<2>::msh);
+ check_file<2> (std::string("mesh"), GridIn<2>::msh);
}
#include <iomanip>
#include <string>
-std::ofstream logfile("grid_in_msh_03/output");
+std::ofstream logfile("output");
template<int dim>
void filename_resolution()
{
- check_file<2> (std::string("grid_in_msh_03/mesh"), GridIn<2>::msh);
+ check_file<2> (std::string("mesh"), GridIn<2>::msh);
}
#include <iomanip>
#include <string>
-std::ofstream logfile("grid_in_msh_version_1/output");
+std::ofstream logfile("output");
template<int dim>
void filename_resolution()
{
- check_file<2> (std::string("grid_in_msh_version_1/input_v1"), GridIn<2>::msh);
- check_file<2> (std::string("grid_in_msh_version_1/input_v2"), GridIn<2>::msh);
+ check_file<2> (std::string("input_v1"), GridIn<2>::msh);
+ check_file<2> (std::string("input_v2"), GridIn<2>::msh);
}
#include <iomanip>
#include <string>
-std::ofstream logfile("grid_in_msh_version_2/output");
+std::ofstream logfile("output");
template<int dim>
void filename_resolution()
{
- check_file<2> (std::string("grid_in_msh_version_2/hole81"), GridIn<2>::msh);
- check_file<2> (std::string("grid_in_msh_version_2/hole8170"), GridIn<2>::msh);
+ check_file<2> (std::string("hole81"), GridIn<2>::msh);
+ check_file<2> (std::string("hole8170"), GridIn<2>::msh);
}
#include <iomanip>
#include <string>
-std::ofstream logfile("grid_in_tecplot/output");
+std::ofstream logfile("output");
template <int dim>
int main ()
{
- test<2> ("grid_in_tecplot/1.dat");
- test<2> ("grid_in_tecplot/2.dat");
- test<2> ("grid_in_tecplot/3.dat");
- test<2> ("grid_in_tecplot/4.dat");
+ test<2> ("1.dat");
+ test<2> ("2.dat");
+ test<2> ("3.dat");
+ test<2> ("4.dat");
}
#include <iomanip>
#include <string>
-std::ofstream logfile("grid_in_unv_2d/output");
+std::ofstream logfile("output");
template<int dim>
void filename_resolution()
{
- check_file<2> (std::string("grid_in_unv_2d/test1427"), GridIn<2>::unv);
- check_file<2> (std::string("grid_in_unv_2d/test46"), GridIn<2>::unv);
+ check_file<2> (std::string("test1427"), GridIn<2>::unv);
+ check_file<2> (std::string("test46"), GridIn<2>::unv);
}
#include <iomanip>
#include <string>
-std::ofstream logfile("grid_in_unv_3d/output");
+std::ofstream logfile("output");
template<int dim>
void filename_resolution()
{
- check_file<3> (std::string("grid_in_unv_3d/3D"), GridIn<3>::unv);
+ check_file<3> (std::string("3D"), GridIn<3>::unv);
}
#include <fstream>
#include <string>
-std::ofstream logfile("grid_invert/output");
+std::ofstream logfile("output");
template <int dim>
void test (bool second_case=false)
#include <iomanip>
-std::ofstream logfile("grid_out/output");
+std::ofstream logfile("output");
template <int dim>
#include <iomanip>
-std::ofstream logfile("grid_out_02/output");
+std::ofstream logfile("output");
template <int dim>
#include <iomanip>
-std::ofstream logfile("grid_out_03/output");
+std::ofstream logfile("output");
template <int dim>
#include <iomanip>
-std::ofstream logfile("grid_out_04/output");
+std::ofstream logfile("output");
template <int dim>
#include <iomanip>
-std::ofstream logfile("grid_out_05/output");
+std::ofstream logfile("output");
template <int dim>
CylinderBoundary<dim> boundary(.3, 2);
tr.set_boundary(1, boundary);
{
- std::ofstream grid_file("grid_output_input/coarse_grid.inp");
+ std::ofstream grid_file("coarse_grid.inp");
go.write_ucd(tr, grid_file);
grid_file.close();
}
gi.attach_triangulation(tr);
{
deallog << "Read coarse grid" << std::endl;
- std::ifstream grid_file("grid_output_input/coarse_grid.inp");
+ std::ifstream grid_file("coarse_grid.inp");
gi.read_ucd(grid_file);
grid_file.close();
}
go.write_ucd(tr, out);
{
- std::ofstream grid_file("grid_output_input/grid.msh");
+ std::ofstream grid_file("grid.msh");
go.write_msh(tr, grid_file);
grid_file.close();
}
int main()
{
- std::ofstream logfile("grid_output_input/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <iomanip>
// Output
-std::ofstream logfile ("grid_parallelepiped/output");
+std::ofstream logfile ("output");
// The simplest test case is to create a parallelepiped grid, output
// the result, and hope for the best.
#include <iomanip>
// Output
-std::ofstream logfile ("grid_parallelepiped_01/output");
+std::ofstream logfile ("output");
// As sketched in the deal.II docs, the parallelepiped class is just a
// hyper_rectangle in 1d and a parallelogram in 2d. That can checked
#include <iomanip>
// Output
-std::ofstream logfile ("grid_parallelepiped_02/output");
+std::ofstream logfile ("output");
// This test creates a parallelepiped (one element) and the same
// parallelepiped (one element); because the code that makes the two
#include <iomanip>
// Output
-std::ofstream logfile ("grid_parallelepiped_03/output");
+std::ofstream logfile ("output");
// The simplest test case is to create a parallelepiped grid with a
// number of subdivisions and output the result.
#include <iomanip>
#include <cstdio>
-std::ofstream logfile("grid_test/output");
+std::ofstream logfile("output");
// 1: continuous refinement of the unit square always in the middle
// 2: refinement of the circle at the boundary
#include <fstream>
#include <iomanip>
-std::ofstream logfile("grid_tools/output");
+std::ofstream logfile("output");
#include <fstream>
#include <iomanip>
-std::ofstream logfile("grid_tools_02/output");
+std::ofstream logfile("output");
#include <fstream>
#include <iomanip>
-std::ofstream logfile("grid_tools_03/output");
+std::ofstream logfile("output");
#include <fstream>
#include <iomanip>
-std::ofstream logfile("grid_tools_04/output");
+std::ofstream logfile("output");
#include <deal.II/grid/tria.h>
#include <fstream>
-std::ofstream logfile("grid_tools_05/output");
+std::ofstream logfile("output");
using namespace dealii;
tria.set_boundary(1, inner_ball);
GridOut grid_out;
- std::ofstream eps_stream2("grid_transform/output");
+ std::ofstream eps_stream2("output");
grid_out.write_eps(tria, eps_stream2, &mapping);
tria.clear();
GridOut grid_out;
- std::ofstream out("grid_transform_3d/output");
+ std::ofstream out("output");
out.precision (5);
out << std::fixed;
grid_out.write_gnuplot(tria, out);
int main()
{
- std::ofstream logfile ("have_same_coarse_mesh_01/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile ("have_same_coarse_mesh_02/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile ("have_same_coarse_mesh_03/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile ("have_same_coarse_mesh_04/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <iostream>
#include <complex>
-std::ofstream logfile("inhomogeneous_constraints/output");
+std::ofstream logfile("output");
using namespace dealii;
#include <iostream>
#include <complex>
-std::ofstream logfile("inhomogeneous_constraints_02/output");
+std::ofstream logfile("output");
using namespace dealii;
#include <iostream>
#include <complex>
-std::ofstream logfile("inhomogeneous_constraints_03/output");
+std::ofstream logfile("output");
using namespace dealii;
#include <iostream>
#include <complex>
-std::ofstream logfile("inhomogeneous_constraints_04/output");
+std::ofstream logfile("output");
using namespace dealii;
#include <iostream>
#include <complex>
-std::ofstream logfile("inhomogeneous_constraints_block/output");
+std::ofstream logfile("output");
using namespace dealii;
#include <iostream>
#include <complex>
-std::ofstream logfile("inhomogeneous_constraints_nonsymmetric/output");
+std::ofstream logfile("output");
using namespace dealii;
#include <fstream>
#include <sstream>
-std::ofstream logfile("inhomogeneous_constraints_vector/output");
+std::ofstream logfile("output");
using namespace dealii;
-std::ofstream logfile("intergrid_constraints/output");
+std::ofstream logfile("output");
template <int dim>
int main ()
{
- std::ofstream logfile("intergrid_map/output");
+ std::ofstream logfile("output");
deallog << std::setprecision(2);
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile("interpolate_boundary_values_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("interpolate_boundary_values_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile("interpolate_dgq_01/output");
+ std::ofstream logfile("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile("interpolate_dgq_02/output");
+ std::ofstream logfile("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile("interpolate_q_01/output");
+ std::ofstream logfile("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile("interpolate_q_02/output");
+ std::ofstream logfile("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile("interpolate_q_system_01/output");
+ std::ofstream logfile("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile("interpolate_q_system_02/output");
+ std::ofstream logfile("output");
deallog << std::setprecision (3);
deallog.attach(logfile);
//
// the problem was fixed by fixing the code
-char logname[] = "kelly_crash_02/output";
+char logname[] = "output";
#include "../tests.h"
#include <iomanip>
-std::ofstream logfile("line_coarsening_3d/output");
+std::ofstream logfile("output");
// create a triangulation of a cylinder, where the line along the axis is common
int main ()
{
- std::ofstream logfile ("matrices/output");
+ std::ofstream logfile ("output");
logfile << std::setprecision (2);
logfile << std::fixed;
deallog << std::setprecision (2);
#include <iomanip>
-std::ofstream logfile("maximal_cell_diameter/output");
+std::ofstream logfile("output");
int main()
{
- std::ofstream logfile ("measure_et_al/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (PRECISION);
deallog.attach(logfile);
deallog.depth_console(0);
int main()
{
- std::ofstream logfile ("measure_et_al_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (PRECISION);
deallog.attach(logfile);
deallog.depth_console(0);
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("memory_consumption_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
#include <iomanip>
#include <cstdio>
-std::ofstream logfile("merge_triangulations_01/output");
+std::ofstream logfile("output");
// function
-char logname[] = "mesh_smoothing_02/output";
+char logname[] = "output";
#include "../tests.h"
// also investigate all its neighbors as well
-char logname[] = "mesh_smoothing_03/output";
+char logname[] = "output";
#include "../tests.h"
int main ()
{
- std::ofstream logfile("mg_dof_handler/output");
+ std::ofstream logfile("output");
deallog << std::setprecision(2);
deallog.attach(logfile);
#include <iomanip>
-std::ofstream logfile("minimal_cell_diameter/output");
+std::ofstream logfile("output");
int main()
{
- std::string logname = JobIdentifier::base_name(__FILE__) + std::string("/output");
+ std::string logname = "output";
std::ofstream logfile(logname.c_str());
deallog.attach(logfile);
deallog.depth_console(0);
int main()
{
- std::ofstream logfile ("no_flux_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_05/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_06/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_07/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("no_flux_08/output");
+ std::ofstream logfile ("output");
logfile.precision (4);
logfile.setf(std::ios::fixed);
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("no_flux_09/output");
+ std::ofstream logfile ("output");
logfile.precision (4);
logfile.setf(std::ios::fixed);
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("no_flux_10/output");
+ std::ofstream logfile ("output");
logfile.precision (4);
logfile.setf(std::ios::fixed);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_hp_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_hp_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_hp_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_hp_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("no_flux_hp_05/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("normal_vector_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("normal_vector_01_2d/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("normal_vector_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("normal_vector_02_2d/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("normal_vector_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("normal_vector_03_2d/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("normals_at_vertices_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("normals_at_vertices_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
#include <fstream>
#include <iomanip>
-std::ofstream logfile("number_cache_01/output");
+std::ofstream logfile("output");
#include <fstream>
#include <iomanip>
-std::ofstream logfile("number_cache_02/output");
+std::ofstream logfile("output");
#include <fstream>
#include <iomanip>
-std::ofstream logfile("number_cache_03/output");
+std::ofstream logfile("output");
test_copy.evaluate_field("Solution", solution);
std::vector <double> input_value(n_inputs, 1);
test_copy.push_back_independent(input_value);
- test_copy.write_gnuplot("point_value_history_01/Test_Copy");
+ test_copy.write_gnuplot("Test_Copy");
test_copy.status(deallog.get_file_stream());
test_copy.clear ();
// end of assignment operator check
post_processed = solution;
post_processed.add(2.0); // simple post processing, giving it a dc offset
}
- node_monitor.write_gnuplot("point_value_history_01/node");
- no_dof_handler.write_gnuplot("point_value_history_01/no_dof");
+ node_monitor.write_gnuplot("node");
+ no_dof_handler.write_gnuplot("no_dof");
node_monitor.status (deallog.get_file_stream());
no_dof_handler.status (deallog.get_file_stream());
// copy all the data into deallog and
// delete those files
const std::string filenames[]
- = { "point_value_history_01/node_00.gpl",
- "point_value_history_01/node_01.gpl",
- "point_value_history_01/node_02.gpl",
- "point_value_history_01/node_03.gpl",
- "point_value_history_01/node_04.gpl",
- "point_value_history_01/node_05.gpl",
- "point_value_history_01/node_indep.gpl",
- "point_value_history_01/Test_Copy_00.gpl",
- "point_value_history_01/Test_Copy_indep.gpl",
- "point_value_history_01/no_dof_indep.gpl"
+ = { "node_00.gpl",
+ "node_01.gpl",
+ "node_02.gpl",
+ "node_03.gpl",
+ "node_04.gpl",
+ "node_05.gpl",
+ "node_indep.gpl",
+ "Test_Copy_00.gpl",
+ "Test_Copy_indep.gpl",
+ "no_dof_indep.gpl"
};
for (unsigned int i=0; i<sizeof(filenames)/sizeof(filenames[0]); ++i)
int main()
{
- std::ofstream logfile("point_value_history_01/output");
+ std::ofstream logfile("output");
logfile << std::setprecision(2);
deallog << std::setprecision(2);
deallog.attach(logfile);
test_copy.evaluate_field("Solution", solution);
std::vector <double> input_value(n_inputs, 1);
test_copy.push_back_independent(input_value);
- test_copy.write_gnuplot("point_value_history_02/Test_Copy");
+ test_copy.write_gnuplot("Test_Copy");
test_copy.status(deallog.get_file_stream());
test_copy.clear ();
// end of assignment operator check
post_processed.add(2.0); // simple post processing, giving it a dc offset
}
triangulation.refine_global(1); // should mark the triangulation as changed
- node_monitor.write_gnuplot("point_value_history_02/node", postprocessor_locations);
- no_dof_handler.write_gnuplot("point_value_history_02/no_dof");
+ node_monitor.write_gnuplot("node", postprocessor_locations);
+ no_dof_handler.write_gnuplot("no_dof");
node_monitor.status (deallog.get_file_stream());
no_dof_handler.status (deallog.get_file_stream());
// copy all the data into deallog and
// delete those files
const std::string filenames[]
- = { "point_value_history_02/node_00.gpl",
- "point_value_history_02/node_01.gpl",
- "point_value_history_02/node_02.gpl",
- "point_value_history_02/node_03.gpl",
- "point_value_history_02/node_04.gpl",
- "point_value_history_02/node_05.gpl",
- "point_value_history_02/node_indep.gpl",
- "point_value_history_02/Test_Copy_00.gpl",
- "point_value_history_02/Test_Copy_indep.gpl",
- "point_value_history_02/no_dof_indep.gpl"
+ = { "node_00.gpl",
+ "node_01.gpl",
+ "node_02.gpl",
+ "node_03.gpl",
+ "node_04.gpl",
+ "node_05.gpl",
+ "node_indep.gpl",
+ "Test_Copy_00.gpl",
+ "Test_Copy_indep.gpl",
+ "no_dof_indep.gpl"
};
for (unsigned int i=0; i<sizeof(filenames)/sizeof(filenames[0]); ++i)
data_out.build_patches (2);
std::ostringstream filename;
- filename << "point_value_history_02/solution-"
+ filename << "solution-"
<< Utilities::int_to_string (step, 2)
<< ".gpl";
int main()
{
- std::ofstream logfile("point_value_history_02/output");
+ std::ofstream logfile("output");
logfile << std::setprecision(2);
deallog << std::setprecision(2);
deallog.attach(logfile);
test_copy.evaluate_field("Solution", solution);
std::vector <double> input_value(n_inputs, 1);
test_copy.push_back_independent(input_value);
- test_copy.write_gnuplot("point_value_history_03/Test_Copy");
+ test_copy.write_gnuplot("Test_Copy");
test_copy.status(deallog.get_file_stream());
test_copy.clear ();
// end of assignment operator check
post_processed = solution;
post_processed.add(2.0); // simple post processing, giving it a dc offset
}
- node_monitor.write_gnuplot("point_value_history_03/node", postprocessor_locations);
- no_dof_handler.write_gnuplot("point_value_history_03/no_dof"); // no point in adding postprocessor_locations
+ node_monitor.write_gnuplot("node", postprocessor_locations);
+ no_dof_handler.write_gnuplot("no_dof"); // no point in adding postprocessor_locations
node_monitor.status (deallog.get_file_stream());
no_dof_handler.status (deallog.get_file_stream());
// copy all the data into deallog and
// delete those files
const std::string filenames[]
- = { "point_value_history_03/node_00.gpl",
- "point_value_history_03/node_01.gpl",
- "point_value_history_03/node_02.gpl",
- "point_value_history_03/node_03.gpl",
- "point_value_history_03/node_04.gpl",
- "point_value_history_03/node_05.gpl",
- "point_value_history_03/node_indep.gpl",
- "point_value_history_03/Test_Copy_00.gpl",
- "point_value_history_03/Test_Copy_indep.gpl",
- "point_value_history_03/no_dof_indep.gpl"
+ = { "node_00.gpl",
+ "node_01.gpl",
+ "node_02.gpl",
+ "node_03.gpl",
+ "node_04.gpl",
+ "node_05.gpl",
+ "node_indep.gpl",
+ "Test_Copy_00.gpl",
+ "Test_Copy_indep.gpl",
+ "no_dof_indep.gpl"
};
for (unsigned int i=0; i<sizeof(filenames)/sizeof(filenames[0]); ++i)
data_out.build_patches (2);
std::ostringstream filename;
- filename << "point_value_history_03/solution-"
+ filename << "solution-"
<< Utilities::int_to_string (step, 2)
<< ".gpl";
int main()
{
- std::ofstream logfile("point_value_history_03/output");
+ std::ofstream logfile("output");
logfile << std::setprecision(2);
deallog << std::setprecision(2);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("project_01/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile ("project_01_curved_boundary/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile ("project_02/output");
+ std::ofstream logfile ("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main()
{
- std::ofstream logfile ("project_boundary_rt_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/numerics/vector_tools.h>
-std::ofstream logfile ("project_bv_curl_conf/output");
+std::ofstream logfile ("output");
template <int dim>
class BoundaryFunction: public Function<dim>
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/numerics/vector_tools.h>
-std::ofstream logfile ("project_bv_div_conf/output");
+std::ofstream logfile ("output");
template <int dim>
class BoundaryFunction: public Function<dim>
// check that VectorTools::project works for DGP elements correctly
-char logname[] = "project_dgp_01/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for DGP elements correctly
-char logname[] = "project_dgp_02/output";
+char logname[] = "output";
#include "project_common.h"
// convergence, which we have to specify in the last argument to the
// call below
-char logname[] = "project_dgp_03/output";
+char logname[] = "output";
#include "project_common.h"
// convergence, which we have to specify in the last argument to the
// call below
-char logname[] = "project_dgp_04/output";
+char logname[] = "output";
#include "project_common.h"
// convergence, which we have to specify in the last argument to the
// call below
-char logname[] = "project_dgp_05/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for DGP_Monomial elements correctly
-char logname[] = "project_dgp_monomial_01/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for DGP_Monomial elements correctly
-char logname[] = "project_dgp_monomial_02/output";
+char logname[] = "output";
#include "project_common.h"
// convergence, which we have to specify in the last argument to the
// call below
-char logname[] = "project_dgp_monomial_03/output";
+char logname[] = "output";
#include "project_common.h"
// convergence, which we have to specify in the last argument to the
// call below
-char logname[] = "project_dgp_monomial_04/output";
+char logname[] = "output";
#include "project_common.h"
// convergence, which we have to specify in the last argument to the
// call below
-char logname[] = "project_dgp_monomial_05/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for DGQ elements correctly
-char logname[] = "project_dgq_01/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for DGQ elements correctly
-char logname[] = "project_dgq_02/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for DGQ elements correctly
-char logname[] = "project_dgq_03/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for DGQ elements correctly
-char logname[] = "project_dgq_04/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for DGQ elements correctly
-char logname[] = "project_dgq_05/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for Nedelec elements correctly
-char logname[] = "project_nedelec_01/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for Nedelec elements correctly
-char logname[] = "project_nedelec_02/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for Nedelec elements correctly
-char logname[] = "project_nedelec_03/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for Nedelec elements correctly
-char logname[] = "project_nedelec_04/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for Nedelec elements correctly
-char logname[] = "project_nedelec_05/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for Q elements correctly
-char logname[] = "project_q_01/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for Q elements correctly
-char logname[] = "project_q_02/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for Q elements correctly
-char logname[] = "project_q_03/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for Q elements correctly
-char logname[] = "project_q_04/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for Q elements correctly
-char logname[] = "project_q_05/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for QHierarchical elements correctly
-char logname[] = "project_q_hierarchical_01/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for QHierarchical elements correctly
-char logname[] = "project_q_hierarchical_02/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for QHierarchical elements correctly
-char logname[] = "project_q_hierarchical_03/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for QHierarchical elements correctly
-char logname[] = "project_q_hierarchical_04/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for QHierarchical elements correctly
-char logname[] = "project_q_hierarchical_05/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for FESystem(FE_Q) elements correctly
// on a uniformly refined mesh for functions of degree q
-char logname[] = "project_q_system_01/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for FESystem(FE_Q) elements correctly
// on a uniformly refined mesh for functions of degree q
-char logname[] = "project_q_system_02/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for FESystem(FE_Q) elements correctly
// on a uniformly refined mesh for functions of degree q
-char logname[] = "project_q_system_03/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for FESystem(FE_Q) elements correctly
// on a uniformly refined mesh for functions of degree q
-char logname[] = "project_q_system_04/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for FESystem(FE_Q) elements correctly
// on a uniformly refined mesh for functions of degree q
-char logname[] = "project_q_system_05/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for RT elements correctly
-char logname[] = "project_rt_01/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for RT elements correctly
-char logname[] = "project_rt_02/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for RT elements correctly
-char logname[] = "project_rt_04/output";
+char logname[] = "output";
#include "project_common.h"
// check that VectorTools::project works for RT elements correctly
-char logname[] = "project_rt_05/output";
+char logname[] = "output";
#include "project_common.h"
int main ()
{
- std::ofstream logfile ("project_to_surface_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("project_to_surface_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("project_to_surface_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (3);
deallog << std::fixed;
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("recursively_set_material_id/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
#include <iomanip>
#include <cstdio>
-std::ofstream logfile("refinement_listener_01/output");
+std::ofstream logfile("output");
template <int dim, int spacedim = dim>
#include <iomanip>
#include <cstdio>
-std::ofstream logfile("refinement_listener_02/output");
+std::ofstream logfile("output");
#include <iomanip>
#include <cstdio>
-std::ofstream logfile("refinement_listener_03/output");
+std::ofstream logfile("output");
int main()
{
- std::ofstream logfile ("rt_covariant/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
int main()
{
- std::ofstream logfile ("rt_hessian/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("sparsity_pattern/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("sparsity_pattern_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("sparsity_pattern_01_x/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("sparsity_pattern_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("sparsity_pattern_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("sparsity_pattern_04/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("sparsity_pattern_05/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("sparsity_pattern_05_x/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("sparsity_pattern_x/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (2);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile("subcelldata/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
#include <cmath>
-std::ofstream logfile("subdomain_ids/output");
+std::ofstream logfile("output");
DeclException2 (ExcNumberMismatch,
#include <cmath>
-std::ofstream logfile("subdomain_on_refinement/output");
+std::ofstream logfile("output");
DeclException2 (ExcNumberMismatch,
#include <cmath>
-std::ofstream logfile("time_dependent_01/output");
+std::ofstream logfile("output");
std::vector<bool> end_sweep_flags;
#include <fstream>
#include <iomanip>
-std::ofstream logfile("tria_iterator_with_one_header/output");
+std::ofstream logfile("output");
template <int dim>
#include <iomanip>
#include <cstdio>
-std::ofstream logfile("tria_last/output");
+std::ofstream logfile("output");
#include <iomanip>
#include <cstdio>
-std::ofstream logfile("union_triangulation/output");
+std::ofstream logfile("output");
{
deal_II_exceptions::disable_abort_on_exception();
- std::ofstream logfile("user_data_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
deallog.threshold_double(1.e-10);
int main ()
{
- std::ofstream logfile ("vectors_boundary_rhs_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (4);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("vectors_boundary_rhs_02/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (4);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("vectors_boundary_rhs_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (4);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("vectors_point_source_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (4);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("vectors_rhs_01/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (4);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile ("vectors_rhs_03/output");
+ std::ofstream logfile ("output");
deallog << std::setprecision (4);
deallog << std::fixed;
deallog.attach(logfile);
int main ()
{
- std::ofstream logfile("vertex_as_face_01/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_02/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_03/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_04/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_05/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_06/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_07/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_08/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_09/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_10/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_11/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_12/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);
int main ()
{
- std::ofstream logfile("vertex_as_face_13/output");
+ std::ofstream logfile("output");
deallog.attach(logfile);
deallog.depth_console(0);