]> https://gitweb.dealii.org/ - dealii.git/commit
std::[io]fstream can now deal with std::string for filenames. 15694/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Sun, 9 Jul 2023 23:00:24 +0000 (17:00 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Sun, 9 Jul 2023 23:01:57 +0000 (17:01 -0600)
commitb0ab1cc8d68bf6220c07a5d93893b52cd5bc0632
treeec55dfec920c2c47c5f1ab9b9537e694aed56ba3
parent01b805b00b621143e6ca89ff13dfde00807e0e31
std::[io]fstream can now deal with std::string for filenames.
171 files changed:
examples/step-63/step-63.cc
include/deal.II/base/path_search.h
include/deal.II/numerics/dof_output_operator.templates.h
include/deal.II/numerics/dof_print_solver_step.h
source/base/data_out_base.cc
source/base/parameter_handler.cc
source/distributed/fully_distributed_tria.cc
source/distributed/tria.cc
source/grid/grid_in.cc
source/grid/grid_out.cc
source/numerics/point_value_history.cc
tests/ad_common_tests/step-44-helper_res_lin_01.h
tests/ad_common_tests/step-44-helper_scalar_01.h
tests/ad_common_tests/step-44-helper_var_form_01.h
tests/ad_common_tests/step-44-helper_vector_01.h
tests/adolc/step-44.cc
tests/aniso/refine_and_coarsen_anisotropic.cc
tests/bits/joa_1.cc
tests/bits/step-4_dg_periodic.cc
tests/bits/step-4_dg_periodic_coupling.cc
tests/codim_one/bem.cc
tests/codim_one/data_out.cc
tests/codim_one/error_estimator_02.cc
tests/codim_one/gradients.cc
tests/codim_one/gradients_1.cc
tests/codim_one/grid_in_out.cc
tests/codim_one/grid_in_out_02.cc
tests/codim_one/grid_in_out_03.cc
tests/codim_one/grid_refinement.cc
tests/codim_one/interpolate_boundary_values_01.cc
tests/codim_one/interpolate_boundary_values_01_vector_valued.cc
tests/codim_one/interpolation.cc
tests/codim_one/interpolation_2.cc
tests/codim_one/interpolation_3.cc
tests/codim_one/mapping_fe_field_01.cc
tests/codim_one/mapping_q1.cc
tests/codim_one/mapping_q1_eulerian.cc
tests/codim_one/mapping_q_eulerian.cc
tests/codim_one/projection.cc
tests/codim_one/projection_dgp.cc
tests/codim_one/renumber_component_wise_01.cc
tests/codim_one/surface.cc
tests/data_out/data_out_hdf5_02.cc
tests/distributed_grids/2d_refinement_10.cc
tests/distributed_grids/3d_refinement_12.cc
tests/distributed_grids/coarse_grid_common.h
tests/dofs/dof_renumbering_10.cc
tests/dofs/dof_tools_extract_dofs_with_support_contained_within_01.cc
tests/dofs/dof_tools_extract_dofs_with_support_contained_within_02.cc
tests/dofs/dof_tools_extract_dofs_with_support_contained_within_03.cc
tests/dofs/dof_tools_extract_dofs_with_support_contained_within_04.cc
tests/dofs/locally_relevant_dofs_per_subdomain_01.cc
tests/dofs/locally_relevant_dofs_per_subdomain_01_hp.cc
tests/dofs/range_based_for_step-6.cc
tests/fe/fe_enriched_04.cc
tests/fe/fe_enriched_05.cc
tests/fe/fe_enriched_06.cc
tests/fe/fe_enriched_07.cc
tests/fe/fe_enriched_08.cc
tests/fe/fe_enriched_color_05.cc
tests/fe/fe_enriched_color_07.cc
tests/fe/fe_enriched_color_08.cc
tests/fe/fe_enriched_step-36.cc
tests/fe/fe_enriched_step-36b.cc
tests/fe/fe_system_components_base.cc
tests/fe/fe_tools_test.cc
tests/fe/nedelec_crash_01.cc
tests/fe/shapes_faceq.cc
tests/fe/shapes_traceq.cc
tests/grid/grid_generator_plate_with_a_hole.cc
tests/grid/grid_generator_plate_with_a_hole_2.cc
tests/grid/grid_generator_plate_with_a_hole_3.cc
tests/grid/grid_generator_plate_with_a_hole_4.cc
tests/grid/grid_out_vtk_02.cc
tests/grid/grid_tools_active_cell_layer_within_distance_01.cc
tests/grid/grid_tools_active_cell_layer_within_distance_02.cc
tests/grid/grid_tools_halo_layer_01.cc
tests/grid/grid_tools_halo_layer_02.cc
tests/grid/grid_tools_halo_layer_03.cc
tests/grid/grid_tools_halo_layer_04.cc
tests/grid/grid_tools_halo_layer_05.cc
tests/hp/crash_17.cc
tests/hp/crash_18.cc
tests/hp/hp_constraints_neither_dominate_01.cc
tests/hp/hp_constraints_neither_dominate_02.cc
tests/hp/hp_q_hierarchical_constraints.cc
tests/hp/laplace.h
tests/hp/step-27.cc
tests/integrators/assembler_simple_matrix_01.cc
tests/integrators/assembler_simple_matrix_01m.cc
tests/integrators/assembler_simple_matrix_02.cc
tests/integrators/assembler_simple_matrix_02m.cc
tests/integrators/assembler_simple_matrix_04.cc
tests/integrators/assembler_simple_mgmatrix_01.cc
tests/integrators/assembler_simple_mgmatrix_02.cc
tests/integrators/assembler_simple_mgmatrix_03.cc
tests/integrators/assembler_simple_mgmatrix_04.cc
tests/integrators/cells_and_faces_01.cc
tests/integrators/divergence_01.cc
tests/integrators/functional_01.cc
tests/integrators/mesh_worker_01.cc
tests/integrators/mesh_worker_02.cc
tests/integrators/mesh_worker_03.cc
tests/integrators/mesh_worker_1d_dg.cc
tests/integrators/mesh_worker_matrix_01.cc
tests/lac/solver_relaxation_01.cc
tests/lac/solver_relaxation_02.cc
tests/lac/solver_relaxation_03.cc
tests/lac/solver_relaxation_04.cc
tests/lac/sparse_matrix_Tmmult_01.cc
tests/lac/sparse_matrix_Tmmult_02.cc
tests/lac/sparse_matrix_iterator.cc
tests/lac/sparse_matrix_mmult_01.cc
tests/lac/sparse_matrix_mmult_02.cc
tests/matrix_free/dof_info_01.cc
tests/matrix_free/dof_info_02.cc
tests/matrix_free/interpolate_to_mg.cc
tests/metis/metis_05.cc
tests/mpi/codim_01.cc
tests/mpi/communicate_moved_vertices_03.cc
tests/mpi/data_out_hdf5_02.cc
tests/mpi/fe_tools_extrapolate_common.h
tests/mpi/interpolate_to_different_mesh_01.cc
tests/mpi/mg_01.cc
tests/mpi/mg_05.cc
tests/mpi/mg_06.cc
tests/mpi/muelu_periodicity.cc
tests/mpi/no_flux_constraints_02.cc
tests/mpi/no_flux_constraints_03.cc
tests/mpi/p4est_2d_constraintmatrix_04.cc
tests/mpi/p4est_3d_constraintmatrix_03.cc
tests/mpi/periodicity_01.cc
tests/mpi/periodicity_02.cc
tests/mpi/periodicity_03.cc
tests/mpi/step-37.cc
tests/multigrid/step-16-02.cc
tests/multigrid/step-16-07.cc
tests/multigrid/step-16-08.cc
tests/multigrid/step-16-bdry1.cc
tests/multigrid/step-16.cc
tests/multigrid/step-39-02.cc
tests/multigrid/step-39-02a.cc
tests/multigrid/step-39-03.cc
tests/multigrid/step-39.cc
tests/multigrid/transfer_04.cc
tests/multigrid/transfer_04a.cc
tests/multigrid/transfer_04b.cc
tests/multigrid/transfer_system_adaptive_09.cc
tests/numerics/error_estimator_02.cc
tests/numerics/error_estimator_02_complex.cc
tests/numerics/no_flux_12.cc
tests/numerics/point_value_history_01.cc
tests/numerics/point_value_history_02.cc
tests/numerics/point_value_history_03.cc
tests/optimization/step-44.h
tests/parameter_handler/parameter_acceptor_05.cc
tests/parameter_handler/parameter_acceptor_06.cc
tests/physics/step-18-rotation_matrix.cc
tests/physics/step-18.cc
tests/physics/step-44-dgp_monomial.cc
tests/physics/step-44-standard_tensors-material_push_forward.cc
tests/physics/step-44-standard_tensors-spatial.cc
tests/physics/step-44.cc
tests/quick_tests/lapack.cc
tests/sharedtria/tria_01.cc
tests/sharedtria/tria_02.cc
tests/simplex/data_out_write_hdf5_01.cc
tests/simplex/data_out_write_hdf5_02.cc
tests/simplex/poisson_02.cc
tests/symengine/sd_common_tests/step-44-sd-quadrature_level.h
tests/trilinos/solver_control_06.cc

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.