]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Update copyright years. 18592/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Fri, 27 Jun 2025 15:58:34 +0000 (09:58 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Fri, 27 Jun 2025 15:58:34 +0000 (09:58 -0600)
1557 files changed:
cmake/checks/check_01_cpu_features.cmake
cmake/checks/check_01_cxx_features.cmake
cmake/checks/check_02_compiler_features.cmake
cmake/checks/check_02_system_features.cmake
cmake/config/CMakeLists.txt
cmake/config/ConfigGit.cmake.in
cmake/configure/configure_10_lapack.cmake
cmake/configure/configure_10_mpi.cmake
cmake/configure/configure_10_taskflow.cmake
cmake/configure/configure_20_boost.cmake
cmake/configure/configure_20_petsc.cmake
cmake/configure/configure_20_trilinos.cmake
cmake/configure/configure_30_kokkos.cmake
cmake/configure/configure_50_arborx.cmake
cmake/configure/configure_50_complex_values.cmake
cmake/configure/configure_50_magic_enum.cmake
cmake/configure/configure_50_p4est.cmake
cmake/configure/configure_50_psblas.cmake
cmake/configure/configure_50_sundials.cmake
cmake/configure/configure_60_mumps.cmake
cmake/macros/macro_add_flags.cmake
cmake/macros/macro_check_cxx_compiler_bug.cmake
cmake/macros/macro_check_mpi_interface.cmake
cmake/macros/macro_clear_cmake_required.cmake
cmake/macros/macro_collect_source_and_header_files.cmake
cmake/macros/macro_copy_target_properties.cmake
cmake/macros/macro_deal_ii_add_test.cmake
cmake/macros/macro_deal_ii_query_git_information.cmake
cmake/macros/macro_deal_ii_setup_target.cmake
cmake/macros/macro_define_interface_target.cmake
cmake/macros/macro_define_object_library.cmake
cmake/macros/macro_enable_if_links.cmake
cmake/macros/macro_enable_if_supported.cmake
cmake/macros/macro_item_matches.cmake
cmake/macros/macro_populate_target_properties.cmake
cmake/macros/macro_print_target_properties.cmake
cmake/macros/macro_process_feature.cmake
cmake/macros/macro_reset_cmake_required.cmake
cmake/macros/macro_strip_flag.cmake
cmake/macros/macro_strip_known_generator_expressions.cmake
cmake/macros/macro_target_compile_flags.cmake
cmake/macros/macro_target_link_flags.cmake
cmake/modules/FindDEAL_II_ARBORX.cmake
cmake/modules/FindDEAL_II_BOOST.cmake
cmake/modules/FindDEAL_II_KOKKOS.cmake
cmake/modules/FindDEAL_II_MAGIC_ENUM.cmake
cmake/modules/FindDEAL_II_MPI.cmake
cmake/modules/FindDEAL_II_MUMPS.cmake
cmake/modules/FindDEAL_II_P4EST.cmake
cmake/modules/FindDEAL_II_PETSC.cmake
cmake/modules/FindDEAL_II_PSBLAS.cmake
cmake/modules/FindDEAL_II_SUNDIALS.cmake
cmake/modules/FindDEAL_II_TRILINOS.cmake
cmake/scripts/CMakeLists.txt
cmake/setup_cached_variables.cmake
cmake/setup_compiler_flags_gnu.cmake
cmake/setup_compiler_flags_intel.cmake
cmake/setup_compiler_flags_msvc.cmake
cmake/setup_finalize.cmake
cmake/setup_sanity_checks.cmake
cmake/setup_write_config.cmake
contrib/python-bindings/source/__init__.py
contrib/python-bindings/tests/cell_accessor_wrapper.py
contrib/python-bindings/tests/manifold_wrapper.py
contrib/python-bindings/tests/mapping_wrapper.py
contrib/python-bindings/tests/point_wrapper.py
contrib/python-bindings/tests/quadrature_wrapper.py
contrib/python-bindings/tests/triangulation_wrapper.py
contrib/utilities/build_primary_interface_unit.py
contrib/utilities/check_encoding.py
contrib/utilities/count_lines.sh
contrib/utilities/detect_include_cycles.py
contrib/utilities/double_word_typos.py
contrib/utilities/indent
contrib/utilities/indent-all
contrib/utilities/indent.py
contrib/utilities/indent_common.sh
contrib/utilities/parse_ctest_output.py
contrib/utilities/print_deprecated.py
contrib/utilities/prm_tools.py
contrib/utilities/relocate_libraries.py
contrib/utilities/run_clang_tidy.sh
contrib/utilities/update-copyright.sh
contrib/utilities/wrapcomments.py
doc/doxygen/CMakeLists.txt
doc/doxygen/code-gallery/CMakeLists.txt
doc/doxygen/headers/coding_conventions.h
doc/doxygen/headers/concepts.h
doc/doxygen/headers/constraints.h
doc/doxygen/headers/distributed.h
doc/doxygen/headers/dofs.h
doc/doxygen/headers/exceptions.h
doc/doxygen/headers/fe.h
doc/doxygen/headers/geodynamics.h
doc/doxygen/headers/geometry_and_primitives.h
doc/doxygen/headers/glossary.h
doc/doxygen/headers/grid.h
doc/doxygen/headers/instantiations.h
doc/doxygen/headers/integrators.h
doc/doxygen/headers/lac.h
doc/doxygen/headers/laoperators.h
doc/doxygen/headers/main.h
doc/doxygen/headers/manifold.h
doc/doxygen/headers/matrices.h
doc/doxygen/headers/matrixfree.h
doc/doxygen/headers/memory.h
doc/doxygen/headers/mesh_worker.h
doc/doxygen/headers/multithreading.h
doc/doxygen/headers/numerical_algorithms.h
doc/doxygen/headers/parallel.h
doc/doxygen/headers/petsc.h
doc/doxygen/headers/physics.h
doc/doxygen/headers/polynomials.h
doc/doxygen/headers/preconditioners.h
doc/doxygen/headers/quadrature.h
doc/doxygen/headers/reordering.h
doc/doxygen/headers/simplex.h
doc/doxygen/headers/slepc.h
doc/doxygen/headers/solvers.h
doc/doxygen/headers/trilinos.h
doc/doxygen/headers/utilities.h
doc/doxygen/headers/vector_memory.h
doc/doxygen/scripts/code-gallery.pl
doc/doxygen/scripts/make_gallery.pl
doc/doxygen/scripts/make_step.pl
doc/doxygen/scripts/program2toc.pl
doc/doxygen/scripts/steps.pl
doc/doxygen/tutorial/tutorial.h.in
doc/news/3.1.0-vs-3.2.0.h
doc/news/5.1.0-vs-5.2.0.h
doc/news/7.2.0-vs-7.3.0.h
doc/news/8.1.0-vs-8.2.0.h
examples/CMakeLists.txt
examples/step-11/step-11.cc
examples/step-18/step-18.cc
examples/step-21/step-21.cc
examples/step-22/step-22.cc
examples/step-32/step-32.cc
examples/step-38/step-38.cc
examples/step-39/step-39.cc
examples/step-42/step-42.cc
examples/step-43/step-43.cc
examples/step-44/step-44.cc
examples/step-49/step-49.cc
examples/step-51/step-51.cc
examples/step-56/step-56.cc
examples/step-62/step-62.cc
examples/step-64/step-64.cc
examples/step-69/step-69.cc
examples/step-79/step-79.cc
examples/step-8/step-8.cc
examples/step-81/step-81.cc
examples/step-90/step-90.cc
examples/step-93/step-93.cc
examples/step-97/sphere_r6.geo
examples/step-97/sphere_r7.geo
examples/step-97/sphere_r8.geo
examples/step-97/sphere_r9.geo
examples/step-97/step-97.cc
include/CMakeLists.txt
include/deal.II/CMakeLists.txt
include/deal.II/algorithms/any_data.h
include/deal.II/algorithms/general_data_storage.h
include/deal.II/algorithms/named_selection.h
include/deal.II/algorithms/newton.h
include/deal.II/algorithms/operator.h
include/deal.II/algorithms/theta_timestepping.h
include/deal.II/algorithms/theta_timestepping.templates.h
include/deal.II/arborx/bvh.h
include/deal.II/base/CMakeLists.txt
include/deal.II/base/aligned_vector.h
include/deal.II/base/array_view.h
include/deal.II/base/bounding_box.h
include/deal.II/base/complex_overloads.h
include/deal.II/base/config.h.in
include/deal.II/base/convergence_table.h
include/deal.II/base/data_out_base.h
include/deal.II/base/derivative_form.h
include/deal.II/base/discrete_time.h
include/deal.II/base/enable_observer_pointer.h
include/deal.II/base/exception_macros.h
include/deal.II/base/exceptions.h
include/deal.II/base/function.h
include/deal.II/base/function.templates.h
include/deal.II/base/function_bessel.h
include/deal.II/base/function_cspline.h
include/deal.II/base/function_derivative.h
include/deal.II/base/function_restriction.h
include/deal.II/base/function_tools.h
include/deal.II/base/geometry_info.h
include/deal.II/base/graph_coloring.h
include/deal.II/base/hdf5.h
include/deal.II/base/index_set.h
include/deal.II/base/init_finalize.h
include/deal.II/base/iterator_range.h
include/deal.II/base/linear_index_iterator.h
include/deal.II/base/memory_consumption.h
include/deal.II/base/memory_space.h
include/deal.II/base/memory_space_data.h
include/deal.II/base/mg_level_object.h
include/deal.II/base/mpi.h
include/deal.II/base/mpi.templates.h
include/deal.II/base/mpi_consensus_algorithms.h
include/deal.II/base/mpi_consensus_algorithms.templates.h
include/deal.II/base/mpi_large_count.h
include/deal.II/base/mpi_noncontiguous_partitioner.h
include/deal.II/base/mpi_noncontiguous_partitioner.templates.h
include/deal.II/base/mpi_remote_point_evaluation.h
include/deal.II/base/mpi_stub.h
include/deal.II/base/mpi_tags.h
include/deal.II/base/mu_parser_internal.h
include/deal.II/base/numbers.h
include/deal.II/base/observer_pointer.h
include/deal.II/base/parallel.h
include/deal.II/base/parameter_acceptor.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/parsed_convergence_table.h
include/deal.II/base/parsed_function.h
include/deal.II/base/partitioner.h
include/deal.II/base/partitioner.templates.h
include/deal.II/base/path_search.h
include/deal.II/base/patterns.h
include/deal.II/base/point.h
include/deal.II/base/polynomial.h
include/deal.II/base/polynomials_bernstein.h
include/deal.II/base/polynomials_hermite.h
include/deal.II/base/polynomials_piecewise.h
include/deal.II/base/polynomials_pyramid.h
include/deal.II/base/polynomials_rannacher_turek.h
include/deal.II/base/polynomials_raviart_thomas.h
include/deal.II/base/polynomials_vector_anisotropic.h
include/deal.II/base/polynomials_wedge.h
include/deal.II/base/process_grid.h
include/deal.II/base/qprojector.h
include/deal.II/base/quadrature.h
include/deal.II/base/revision.h.in
include/deal.II/base/sacado_product_type.h
include/deal.II/base/signaling_nan.h
include/deal.II/base/smartpointer.h
include/deal.II/base/std_cxx17/algorithm.h
include/deal.II/base/std_cxx17/optional.h
include/deal.II/base/std_cxx17/tuple.h
include/deal.II/base/std_cxx17/variant.h
include/deal.II/base/subscriptor.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/symmetric_tensor.templates.h
include/deal.II/base/synchronous_iterator.h
include/deal.II/base/table.h
include/deal.II/base/table_handler.h
include/deal.II/base/template_constraints.h
include/deal.II/base/tensor.h
include/deal.II/base/tensor_accessors.h
include/deal.II/base/tensor_function.h
include/deal.II/base/thread_management.h
include/deal.II/base/time_stepping.h
include/deal.II/base/time_stepping.templates.h
include/deal.II/base/trilinos_utilities.h
include/deal.II/base/types.h
include/deal.II/base/undefine_macros.h
include/deal.II/base/utilities.h
include/deal.II/base/vector_slice.h
include/deal.II/base/vectorization.h
include/deal.II/base/work_stream.h
include/deal.II/boost_adaptors/bounding_box.h
include/deal.II/boost_adaptors/point.h
include/deal.II/cgal/surface_mesh.h
include/deal.II/cgal/triangulation.h
include/deal.II/cgal/utilities.h
include/deal.II/differentiation/ad/ad_drivers.h
include/deal.II/differentiation/ad/ad_helpers.h
include/deal.II/differentiation/ad/ad_number_traits.h
include/deal.II/differentiation/ad/adolc_math.h
include/deal.II/differentiation/ad/adolc_number_types.h
include/deal.II/differentiation/ad/adolc_product_types.h
include/deal.II/differentiation/ad/sacado_math.h
include/deal.II/differentiation/ad/sacado_number_types.h
include/deal.II/differentiation/ad/sacado_product_types.h
include/deal.II/differentiation/sd.h
include/deal.II/differentiation/sd/symengine_math.h
include/deal.II/differentiation/sd/symengine_number_traits.h
include/deal.II/differentiation/sd/symengine_number_types.h
include/deal.II/differentiation/sd/symengine_number_visitor_internal.h
include/deal.II/differentiation/sd/symengine_product_types.h
include/deal.II/differentiation/sd/symengine_scalar_operations.h
include/deal.II/differentiation/sd/symengine_tensor_operations.h
include/deal.II/differentiation/sd/symengine_types.h
include/deal.II/differentiation/sd/symengine_utilities.h
include/deal.II/distributed/cell_data_transfer.h
include/deal.II/distributed/cell_weights.h
include/deal.II/distributed/fully_distributed_tria.h
include/deal.II/distributed/p4est_wrappers.h
include/deal.II/distributed/repartitioning_policy_tools.h
include/deal.II/dofs/block_info.h
include/deal.II/dofs/dof_accessor.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/dofs/dof_handler.h
include/deal.II/dofs/dof_handler_policy.h
include/deal.II/dofs/dof_iterator_selector.h
include/deal.II/dofs/dof_levels.h
include/deal.II/dofs/dof_objects.h
include/deal.II/dofs/dof_tools.h
include/deal.II/dofs/number_cache.h
include/deal.II/fe/block_mask.h
include/deal.II/fe/component_mask.h
include/deal.II/fe/fe.h
include/deal.II/fe/fe_abf.h
include/deal.II/fe/fe_base.h
include/deal.II/fe/fe_coupling_values.h
include/deal.II/fe/fe_enriched.h
include/deal.II/fe/fe_interface_values.h
include/deal.II/fe/fe_nedelec.h
include/deal.II/fe/fe_poly_tensor.h
include/deal.II/fe/fe_q_base.h
include/deal.II/fe/fe_q_hierarchical.h
include/deal.II/fe/fe_raviart_thomas.h
include/deal.II/fe/fe_series.h
include/deal.II/fe/fe_simplex_p.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_tools.h
include/deal.II/fe/fe_tools.templates.h
include/deal.II/fe/fe_tools_extrapolate.templates.h
include/deal.II/fe/fe_tools_interpolate.templates.h
include/deal.II/fe/fe_update_flags.h
include/deal.II/fe/fe_values.h
include/deal.II/fe/fe_values_base.h
include/deal.II/fe/fe_values_extractors.h
include/deal.II/fe/mapping.h
include/deal.II/fe/mapping_fe_field.h
include/deal.II/fe/mapping_fe_field.templates.h
include/deal.II/fe/mapping_manifold.h
include/deal.II/fe/mapping_q1_eulerian.h
include/deal.II/fe/mapping_q_cache.h
include/deal.II/fe/mapping_q_eulerian.h
include/deal.II/fe/mapping_q_internal.h
include/deal.II/gmsh/utilities.h
include/deal.II/grid/cell_data.h
include/deal.II/grid/cell_id_translator.h
include/deal.II/grid/cell_status.h
include/deal.II/grid/composition_manifold.h
include/deal.II/grid/connectivity.h
include/deal.II/grid/filtered_iterator.h
include/deal.II/grid/grid_generator.h
include/deal.II/grid/grid_in.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/grid_tools_cache.h
include/deal.II/grid/grid_tools_geometry.h
include/deal.II/grid/grid_tools_topology.h
include/deal.II/grid/intergrid_map.h
include/deal.II/grid/manifold_lib.h
include/deal.II/grid/reference_cell.h
include/deal.II/grid/tensor_product_manifold.h
include/deal.II/grid/tria.h
include/deal.II/grid/tria_accessor.h
include/deal.II/grid/tria_accessor.templates.h
include/deal.II/grid/tria_description.h
include/deal.II/grid/tria_iterator.h
include/deal.II/grid/tria_iterator.templates.h
include/deal.II/grid/tria_iterator_selector.h
include/deal.II/grid/tria_objects_orientations.h
include/deal.II/grid/tria_orientation.h
include/deal.II/hp/collection.h
include/deal.II/hp/fe_collection.h
include/deal.II/hp/mapping_collection.h
include/deal.II/hp/refinement.h
include/deal.II/lac/affine_constraints.h
include/deal.II/lac/affine_constraints.templates.h
include/deal.II/lac/arpack_solver.h
include/deal.II/lac/block_indices.h
include/deal.II/lac/block_linear_operator.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_sparse_matrix.h
include/deal.II/lac/block_sparse_matrix_ez.h
include/deal.II/lac/block_sparse_matrix_ez.templates.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/chunk_sparse_matrix.templates.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/constrained_linear_operator.h
include/deal.II/lac/constraint_matrix.h
include/deal.II/lac/diagonal_matrix.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/lac/full_matrix.h
include/deal.II/lac/full_matrix.templates.h
include/deal.II/lac/generic_linear_algebra.h
include/deal.II/lac/ginkgo_solver.h
include/deal.II/lac/householder.h
include/deal.II/lac/identity_matrix.h
include/deal.II/lac/la_parallel_block_vector.h
include/deal.II/lac/la_parallel_block_vector.templates.h
include/deal.II/lac/la_parallel_vector.h
include/deal.II/lac/la_parallel_vector.templates.h
include/deal.II/lac/lapack_full_matrix.h
include/deal.II/lac/lapack_support.h
include/deal.II/lac/lapack_templates.h
include/deal.II/lac/matrix_block.h
include/deal.II/lac/matrix_iterator.h
include/deal.II/lac/matrix_out.h
include/deal.II/lac/parpack_solver.h
include/deal.II/lac/petsc_block_sparse_matrix.h
include/deal.II/lac/petsc_block_vector.h
include/deal.II/lac/petsc_communication_pattern.h
include/deal.II/lac/petsc_compatibility.h
include/deal.II/lac/petsc_full_matrix.h
include/deal.II/lac/petsc_matrix_free.h
include/deal.II/lac/petsc_parallel_block_sparse_matrix.h
include/deal.II/lac/petsc_parallel_block_vector.h
include/deal.II/lac/petsc_parallel_sparse_matrix.h
include/deal.II/lac/petsc_parallel_vector.h
include/deal.II/lac/petsc_precondition.h
include/deal.II/lac/petsc_snes.h
include/deal.II/lac/petsc_snes.templates.h
include/deal.II/lac/petsc_solver.h
include/deal.II/lac/petsc_sparse_matrix.h
include/deal.II/lac/petsc_ts.templates.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/precondition.h
include/deal.II/lac/precondition_block.h
include/deal.II/lac/precondition_selector.h
include/deal.II/lac/qr.h
include/deal.II/lac/read_vector.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/read_write_vector.templates.h
include/deal.II/lac/relaxation_block.h
include/deal.II/lac/relaxation_block.templates.h
include/deal.II/lac/scalapack.h
include/deal.II/lac/scalapack.templates.h
include/deal.II/lac/schur_complement.h
include/deal.II/lac/slepc_spectral_transformation.h
include/deal.II/lac/solver_cg.h
include/deal.II/lac/solver_control.h
include/deal.II/lac/solver_gmres.h
include/deal.II/lac/solver_idr.h
include/deal.II/lac/solver_minres.h
include/deal.II/lac/sparse_decomposition.h
include/deal.II/lac/sparse_direct.h
include/deal.II/lac/sparse_ilu.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_matrix.templates.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/sparse_matrix_ez.templates.h
include/deal.II/lac/sparse_matrix_tools.h
include/deal.II/lac/sparse_vanka.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/sparsity_pattern_base.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/lac/trilinos_epetra_communication_pattern.h
include/deal.II/lac/trilinos_index_access.h
include/deal.II/lac/trilinos_linear_operator.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/lac/trilinos_solver.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_tpetra_block_sparse_matrix.templates.h
include/deal.II/lac/trilinos_tpetra_block_vector.h
include/deal.II/lac/trilinos_tpetra_block_vector.templates.h
include/deal.II/lac/trilinos_tpetra_communication_pattern.h
include/deal.II/lac/trilinos_tpetra_precondition.h
include/deal.II/lac/trilinos_tpetra_precondition.templates.h
include/deal.II/lac/trilinos_tpetra_solver_direct.h
include/deal.II/lac/trilinos_tpetra_solver_direct.templates.h
include/deal.II/lac/trilinos_tpetra_sparse_matrix.h
include/deal.II/lac/trilinos_tpetra_sparse_matrix.templates.h
include/deal.II/lac/trilinos_tpetra_sparsity_pattern.h
include/deal.II/lac/trilinos_tpetra_types.h
include/deal.II/lac/trilinos_tpetra_vector.h
include/deal.II/lac/trilinos_tpetra_vector.templates.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/vector_element_access.h
include/deal.II/lac/vector_memory.templates.h
include/deal.II/lac/vector_operations_internal.h
include/deal.II/matrix_free/constraint_info.h
include/deal.II/matrix_free/dof_info.h
include/deal.II/matrix_free/dof_info.templates.h
include/deal.II/matrix_free/evaluation_flags.h
include/deal.II/matrix_free/evaluation_kernels.h
include/deal.II/matrix_free/evaluation_kernels_face.h
include/deal.II/matrix_free/evaluation_selector.h
include/deal.II/matrix_free/evaluation_template_face_factory.templates.h
include/deal.II/matrix_free/evaluation_template_factory_hanging_nodes.templates.h
include/deal.II/matrix_free/face_info.h
include/deal.II/matrix_free/face_setup_internal.h
include/deal.II/matrix_free/fe_evaluation.h
include/deal.II/matrix_free/fe_evaluation_data.h
include/deal.II/matrix_free/fe_point_evaluation.h
include/deal.II/matrix_free/hanging_nodes_internal.h
include/deal.II/matrix_free/mapping_data_on_the_fly.h
include/deal.II/matrix_free/mapping_info.h
include/deal.II/matrix_free/mapping_info.templates.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/matrix_free.templates.h
include/deal.II/matrix_free/operators.h
include/deal.II/matrix_free/portable_evaluation_kernels.h
include/deal.II/matrix_free/portable_fe_evaluation.h
include/deal.II/matrix_free/portable_hanging_nodes_internal.h
include/deal.II/matrix_free/portable_matrix_free.h
include/deal.II/matrix_free/portable_matrix_free.templates.h
include/deal.II/matrix_free/portable_tensor_product_kernels.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/matrix_free/tensor_product_kernels.h
include/deal.II/matrix_free/tools.h
include/deal.II/matrix_free/type_traits.h
include/deal.II/matrix_free/vector_access_internal.h
include/deal.II/meshworker/assembler.h
include/deal.II/meshworker/copy_data.h
include/deal.II/meshworker/dof_info.h
include/deal.II/meshworker/functional.h
include/deal.II/meshworker/local_integrator.h
include/deal.II/meshworker/output.h
include/deal.II/meshworker/simple.h
include/deal.II/meshworker/vector_selector.h
include/deal.II/multigrid/mg_base.h
include/deal.II/multigrid/mg_base.templates.h
include/deal.II/multigrid/mg_block_smoother.h
include/deal.II/multigrid/mg_coarse.h
include/deal.II/multigrid/mg_constrained_dofs.h
include/deal.II/multigrid/mg_matrix.h
include/deal.II/multigrid/mg_smoother.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/multigrid/mg_transfer_block.h
include/deal.II/multigrid/mg_transfer_component.h
include/deal.II/multigrid/mg_transfer_global_coarsening.templates.h
include/deal.II/multigrid/mg_transfer_internal.h
include/deal.II/multigrid/mg_transfer_matrix_free.h
include/deal.II/multigrid/mg_transfer_matrix_free.templates.h
include/deal.II/multigrid/multigrid.h
include/deal.II/multigrid/multigrid.templates.h
include/deal.II/multigrid/sparse_matrix_collection.h
include/deal.II/non_matching/immersed_surface_quadrature.h
include/deal.II/non_matching/mapping_info.h
include/deal.II/non_matching/mesh_classifier.h
include/deal.II/non_matching/quadrature_generator.h
include/deal.II/numerics/cell_data_transfer.h
include/deal.II/numerics/cell_data_transfer.templates.h
include/deal.II/numerics/data_out_dof_data.h
include/deal.II/numerics/data_out_dof_data.templates.h
include/deal.II/numerics/data_out_resample.h
include/deal.II/numerics/data_out_stack.h
include/deal.II/numerics/data_postprocessor.h
include/deal.II/numerics/dof_output_operator.h
include/deal.II/numerics/error_estimator.h
include/deal.II/numerics/error_estimator.templates.h
include/deal.II/numerics/fe_field_function.h
include/deal.II/numerics/matrix_creator.templates.h
include/deal.II/numerics/nonlinear.h
include/deal.II/numerics/point_value_history.h
include/deal.II/numerics/rtree.h
include/deal.II/numerics/solution_transfer.h
include/deal.II/numerics/solution_transfer.templates.h
include/deal.II/numerics/tensor_product_matrix_creator.h
include/deal.II/numerics/vector_tools_boundary.h
include/deal.II/numerics/vector_tools_boundary.templates.h
include/deal.II/numerics/vector_tools_constraints.templates.h
include/deal.II/numerics/vector_tools_evaluate.h
include/deal.II/numerics/vector_tools_integrate_difference.h
include/deal.II/numerics/vector_tools_integrate_difference.templates.h
include/deal.II/numerics/vector_tools_interpolate.h
include/deal.II/numerics/vector_tools_interpolate.templates.h
include/deal.II/numerics/vector_tools_mean_value.h
include/deal.II/numerics/vector_tools_mean_value.templates.h
include/deal.II/numerics/vector_tools_point_gradient.h
include/deal.II/numerics/vector_tools_point_value.h
include/deal.II/numerics/vector_tools_point_value.templates.h
include/deal.II/numerics/vector_tools_project.h
include/deal.II/numerics/vector_tools_project.templates.h
include/deal.II/numerics/vector_tools_rhs.h
include/deal.II/numerics/vector_tools_rhs.templates.h
include/deal.II/opencascade/boundary_lib.h
include/deal.II/opencascade/manifold_lib.h
include/deal.II/opencascade/utilities.h
include/deal.II/optimization/rol/vector_adaptor.h
include/deal.II/optimization/solver_bfgs.h
include/deal.II/particles/data_out.h
include/deal.II/particles/particle.h
include/deal.II/particles/particle_accessor.h
include/deal.II/particles/particle_handler.h
include/deal.II/particles/partitioner.h
include/deal.II/particles/property_pool.h
include/deal.II/physics/elasticity/standard_tensors.h
include/deal.II/physics/transformations.h
include/deal.II/sundials/arkode.h
include/deal.II/sundials/ida.h
include/deal.II/sundials/kinsol.h
include/deal.II/sundials/n_vector.h
include/deal.II/sundials/n_vector.templates.h
include/deal.II/sundials/utilities.h
include/deal.II/trilinos/nox.h
include/deal.II/trilinos/nox.templates.h
include/deal.II/vtk/utilities.h
source/CMakeLists.txt
source/algorithms/CMakeLists.txt
source/algorithms/operator.cc
source/arborx/CMakeLists.txt
source/arborx/access_traits.cc
source/base/CMakeLists.txt
source/base/bounding_box.cc
source/base/conditional_ostream.cc
source/base/convergence_table.cc
source/base/data_out_base.cc
source/base/discrete_time.cc
source/base/enable_observer_pointer.cc
source/base/event.cc
source/base/exceptions.cc
source/base/function.cc
source/base/function.inst.in
source/base/function_cspline.cc
source/base/function_derivative.cc
source/base/function_lib.cc
source/base/function_restriction.cc
source/base/function_signed_distance.cc
source/base/function_time.cc
source/base/function_tools.cc
source/base/geometric_utilities.cc
source/base/hdf5.cc
source/base/incremental_function.cc
source/base/index_set.cc
source/base/init_finalize.cc
source/base/job_identifier.cc
source/base/kokkos.cc
source/base/logstream.cc
source/base/mpi.cc
source/base/mpi_noncontiguous_partitioner.cc
source/base/mpi_noncontiguous_partitioner.inst.in
source/base/mpi_remote_point_evaluation.cc
source/base/mu_parser_internal.cc
source/base/multithread_info.cc
source/base/parallel.cc
source/base/parameter_acceptor.cc
source/base/parameter_handler.cc
source/base/parsed_convergence_table.cc
source/base/parsed_function.cc
source/base/partitioner.cc
source/base/path_search.cc
source/base/polynomial.cc
source/base/polynomials_bernardi_raugel.cc
source/base/polynomials_bernstein.cc
source/base/polynomials_integrated_legendre_sz.cc
source/base/polynomials_piecewise.cc
source/base/polynomials_pyramid.cc
source/base/polynomials_rannacher_turek.cc
source/base/polynomials_raviart_thomas.cc
source/base/polynomials_vector_anisotropic.cc
source/base/process_grid.cc
source/base/qprojector.cc
source/base/quadrature.cc
source/base/symbolic_function.cc
source/base/symmetric_tensor.cc
source/base/symmetric_tensor.inst.in
source/base/table_handler.cc
source/base/tensor.cc
source/base/tensor_function.cc
source/base/tensor_function_parser.cc
source/base/tensor_product_polynomials.cc
source/base/tensor_product_polynomials_bubbles.cc
source/base/tensor_product_polynomials_const.cc
source/base/thread_management.cc
source/base/time_stepping.cc
source/base/utilities.cc
source/base/vectorization.cc
source/cgal/CMakeLists.txt
source/cgal/intersections.cc
source/cgal/surface_mesh.cc
source/differentiation/CMakeLists.txt
source/differentiation/ad/CMakeLists.txt
source/differentiation/ad/ad_drivers.cc
source/differentiation/ad/ad_drivers.inst1.in
source/differentiation/ad/ad_helpers.cc
source/differentiation/ad/adolc_number_types.cc
source/differentiation/ad/adolc_number_types.inst.in
source/differentiation/ad/sacado_number_types.cc
source/differentiation/ad/sacado_number_types.inst1.in
source/differentiation/ad/sacado_number_types.inst2.in
source/differentiation/sd/CMakeLists.txt
source/differentiation/sd/symengine_number_visitor_internal.cc
source/differentiation/sd/symengine_number_visitor_internal.inst.in
source/differentiation/sd/symengine_optimizer.cc
source/differentiation/sd/symengine_optimizer.inst.in
source/differentiation/sd/symengine_tensor_operations.cc
source/distributed/CMakeLists.txt
source/distributed/cell_data_transfer.cc
source/distributed/cell_weights.cc
source/distributed/field_transfer.cc
source/distributed/fully_distributed_tria.cc
source/distributed/grid_refinement.cc
source/distributed/p4est_wrappers.cc
source/distributed/repartitioning_policy_tools.cc
source/distributed/shared_tria.cc
source/distributed/tria.cc
source/distributed/tria_base.cc
source/dofs/CMakeLists.txt
source/dofs/block_info.cc
source/dofs/dof_accessor.cc
source/dofs/dof_accessor_get.cc
source/dofs/dof_accessor_set.cc
source/dofs/dof_handler.cc
source/dofs/dof_handler_policy.cc
source/dofs/dof_objects.cc
source/dofs/dof_renumbering.cc
source/dofs/dof_renumbering.inst.in
source/dofs/dof_tools.cc
source/dofs/dof_tools_constraints.cc
source/dofs/dof_tools_constraints.inst.in
source/dofs/dof_tools_sparsity.cc
source/fe/CMakeLists.txt
source/fe/block_mask.cc
source/fe/component_mask.cc
source/fe/fe.cc
source/fe/fe_abf.cc
source/fe/fe_bdm.cc
source/fe/fe_bernstein.cc
source/fe/fe_dg_vector.cc
source/fe/fe_dgp.cc
source/fe/fe_dgp_monomial.cc
source/fe/fe_dgp_nonparametric.cc
source/fe/fe_dgq.cc
source/fe/fe_enriched.cc
source/fe/fe_face.cc
source/fe/fe_hermite.cc
source/fe/fe_nedelec.cc
source/fe/fe_nedelec_sz.cc
source/fe/fe_nothing.cc
source/fe/fe_p1nc.cc
source/fe/fe_poly.cc
source/fe/fe_poly_tensor.cc
source/fe/fe_pyramid_p.cc
source/fe/fe_q.cc
source/fe/fe_q_base.cc
source/fe/fe_q_bubbles.cc
source/fe/fe_q_dg0.cc
source/fe/fe_q_hierarchical.cc
source/fe/fe_q_iso_q1.cc
source/fe/fe_rannacher_turek.cc
source/fe/fe_raviart_thomas.cc
source/fe/fe_raviart_thomas_nodal.cc
source/fe/fe_rt_bubbles.cc
source/fe/fe_series_fourier.cc
source/fe/fe_series_legendre.cc
source/fe/fe_simplex_p.cc
source/fe/fe_simplex_p_bubbles.cc
source/fe/fe_system.cc
source/fe/fe_tools.cc
source/fe/fe_tools.inst.in
source/fe/fe_tools_extrapolate.cc
source/fe/fe_tools_interpolate.cc
source/fe/fe_trace.cc
source/fe/fe_values.cc
source/fe/fe_values_base.cc
source/fe/fe_values_views.cc
source/fe/fe_values_views_internal.cc
source/fe/fe_wedge_p.cc
source/fe/mapping.cc
source/fe/mapping_c1.cc
source/fe/mapping_cartesian.cc
source/fe/mapping_fe.cc
source/fe/mapping_fe_field.cc
source/fe/mapping_fe_field_inst2.cc
source/fe/mapping_manifold.cc
source/fe/mapping_q.cc
source/fe/mapping_q1.cc
source/fe/mapping_q1_eulerian.cc
source/fe/mapping_q_cache.cc
source/fe/mapping_q_eulerian.cc
source/fe/mapping_related_data.cc
source/gmsh/CMakeLists.txt
source/gmsh/utilities.cc
source/grid/CMakeLists.txt
source/grid/cell_id.cc
source/grid/grid_generator.cc
source/grid/grid_generator.inst.in
source/grid/grid_generator_cgal.cc
source/grid/grid_generator_from_name.cc
source/grid/grid_generator_pipe_junction.cc
source/grid/grid_in.cc
source/grid/grid_out.cc
source/grid/grid_refinement.cc
source/grid/grid_tools.cc
source/grid/grid_tools_cache.cc
source/grid/grid_tools_dof_handlers.cc
source/grid/grid_tools_dof_handlers.inst.in
source/grid/grid_tools_geometry.cc
source/grid/grid_tools_topology.cc
source/grid/intergrid_map.cc
source/grid/manifold.cc
source/grid/manifold_lib.cc
source/grid/reference_cell.cc
source/grid/reference_cell.inst.in
source/grid/tria.cc
source/grid/tria_accessor.cc
source/grid/tria_description.cc
source/grid/tria_objects.cc
source/hp/CMakeLists.txt
source/hp/fe_collection.cc
source/hp/fe_values.cc
source/hp/mapping_collection.cc
source/hp/refinement.cc
source/integrators/CMakeLists.txt
source/lac/CMakeLists.txt
source/lac/affine_constraints.cc
source/lac/affine_constraints.inst.in
source/lac/block_sparse_matrix.cc
source/lac/block_sparsity_pattern.cc
source/lac/block_vector.cc
source/lac/chunk_sparse_matrix.cc
source/lac/chunk_sparsity_pattern.cc
source/lac/dynamic_sparsity_pattern.cc
source/lac/exceptions.cc
source/lac/full_matrix.cc
source/lac/la_parallel_block_vector.cc
source/lac/la_parallel_block_vector.inst.in
source/lac/la_parallel_vector.cc
source/lac/lapack_full_matrix.cc
source/lac/matrix_out.cc
source/lac/petsc_communication_pattern.cc
source/lac/petsc_matrix_base.cc
source/lac/petsc_parallel_block_sparse_matrix.cc
source/lac/petsc_parallel_sparse_matrix.cc
source/lac/petsc_parallel_vector.cc
source/lac/petsc_precondition.cc
source/lac/petsc_solver.cc
source/lac/petsc_sparse_matrix.cc
source/lac/petsc_vector_base.cc
source/lac/precondition_block.cc
source/lac/read_write_vector.cc
source/lac/relaxation_block.cc
source/lac/scalapack.cc
source/lac/slepc_solver.cc
source/lac/slepc_spectral_transformation.cc
source/lac/solver.cc
source/lac/solver_gmres.cc
source/lac/solver_gmres.inst.in
source/lac/sparse_matrix.cc
source/lac/sparse_matrix_ez.cc
source/lac/sparse_matrix_inst2.cc
source/lac/sparse_vanka.cc
source/lac/sparsity_pattern.cc
source/lac/sparsity_tools.cc
source/lac/tensor_product_matrix.cc
source/lac/trilinos_block_sparse_matrix.cc
source/lac/trilinos_epetra_vector.cc
source/lac/trilinos_precondition_ml.cc
source/lac/trilinos_precondition_muelu.cc
source/lac/trilinos_solver.cc
source/lac/trilinos_sparse_matrix.cc
source/lac/trilinos_sparsity_pattern.cc
source/lac/trilinos_tpetra_block_sparse_matrix.cc
source/lac/trilinos_tpetra_sparsity_pattern.cc
source/lac/trilinos_vector.cc
source/lac/vector.cc
source/lac/vector_memory.cc
source/matrix_free/CMakeLists.txt
source/matrix_free/dof_info.cc
source/matrix_free/evaluation_template_face_factory.cc
source/matrix_free/evaluation_template_face_factory_inst2.cc
source/matrix_free/evaluation_template_face_factory_inst3.cc
source/matrix_free/evaluation_template_face_factory_inst4.cc
source/matrix_free/evaluation_template_face_factory_inst5.cc
source/matrix_free/evaluation_template_face_factory_inst6.cc
source/matrix_free/evaluation_template_factory.cc
source/matrix_free/evaluation_template_factory_hanging_nodes.cc
source/matrix_free/evaluation_template_factory_inst2.cc
source/matrix_free/evaluation_template_factory_inst3.cc
source/matrix_free/evaluation_template_factory_inst4.cc
source/matrix_free/evaluation_template_factory_inst5.cc
source/matrix_free/evaluation_template_factory_inst6.cc
source/matrix_free/fe_point_evaluation.cc
source/matrix_free/mapping_info.cc
source/matrix_free/mapping_info_inst2.cc
source/matrix_free/mapping_info_inst3.cc
source/matrix_free/matrix_free.cc
source/matrix_free/shape_info.cc
source/matrix_free/task_info.cc
source/meshworker/CMakeLists.txt
source/meshworker/mesh_worker_info.cc
source/meshworker/mesh_worker_vector_selector.cc
source/meshworker/scratch_data.cc
source/multigrid/CMakeLists.txt
source/multigrid/mg_base.cc
source/multigrid/mg_constrained_dofs.cc
source/multigrid/mg_level_global_transfer.cc
source/multigrid/mg_level_global_transfer.inst.in
source/multigrid/mg_tools.cc
source/multigrid/mg_transfer_block.cc
source/multigrid/mg_transfer_component.cc
source/multigrid/mg_transfer_global_coarsening.cc
source/multigrid/mg_transfer_global_coarsening.inst.in
source/multigrid/mg_transfer_internal.cc
source/multigrid/mg_transfer_matrix_free.cc
source/multigrid/mg_transfer_prebuilt.cc
source/multigrid/mg_transfer_prebuilt.inst.in
source/multigrid/multigrid.cc
source/non_matching/CMakeLists.txt
source/non_matching/coupling.cc
source/non_matching/fe_immersed_values.cc
source/non_matching/fe_values.cc
source/non_matching/immersed_surface_quadrature.cc
source/non_matching/mesh_classifier.cc
source/non_matching/quadrature_generator.cc
source/numerics/CMakeLists.txt
source/numerics/cell_data_transfer.cc
source/numerics/data_out.cc
source/numerics/data_out_dof_data.cc
source/numerics/data_out_dof_data_codim.cc
source/numerics/data_out_dof_data_inst2.cc
source/numerics/data_out_faces.cc
source/numerics/data_out_resample.cc
source/numerics/data_out_rotation.cc
source/numerics/data_out_stack.cc
source/numerics/data_postprocessor.cc
source/numerics/derivative_approximation.cc
source/numerics/dof_output_operator.cc
source/numerics/error_estimator.cc
source/numerics/error_estimator_1d.cc
source/numerics/error_estimator_inst2.cc
source/numerics/fe_field_function.cc
source/numerics/matrix_creator.cc
source/numerics/matrix_creator_inst2.cc
source/numerics/matrix_creator_inst3.cc
source/numerics/matrix_tools.cc
source/numerics/matrix_tools_once.cc
source/numerics/point_value_history.cc
source/numerics/smoothness_estimator.cc
source/numerics/solution_transfer.cc
source/numerics/solution_transfer.inst.in
source/numerics/solution_transfer_inst2.cc
source/numerics/solution_transfer_inst3.cc
source/numerics/solution_transfer_inst4.cc
source/numerics/time_dependent.cc
source/numerics/vector_tools_boundary.cc
source/numerics/vector_tools_constraints.cc
source/numerics/vector_tools_integrate_difference.cc
source/numerics/vector_tools_interpolate.cc
source/numerics/vector_tools_mean_value.cc
source/numerics/vector_tools_point_gradient.cc
source/numerics/vector_tools_point_value.cc
source/numerics/vector_tools_project.cc
source/numerics/vector_tools_project_codim.cc
source/numerics/vector_tools_project_hp.cc
source/numerics/vector_tools_project_qp.cc
source/numerics/vector_tools_project_qpmf.cc
source/numerics/vector_tools_rhs.cc
source/numerics/vector_tools_rhs.inst.in
source/opencascade/CMakeLists.txt
source/opencascade/manifold_lib.cc
source/opencascade/utilities.cc
source/optimization/rol/CMakeLists.txt
source/particles/CMakeLists.txt
source/particles/data_out.cc
source/particles/generators.cc
source/particles/particle.cc
source/particles/particle_handler.cc
source/particles/property_pool.cc
source/particles/utilities.cc
source/physics/CMakeLists.txt
source/physics/elasticity/CMakeLists.txt
source/physics/elasticity/kinematics.cc
source/physics/elasticity/standard_tensors.cc
source/physics/transformations.cc
source/sundials/CMakeLists.txt
source/sundials/ida.cc
source/sundials/kinsol.cc
source/sundials/n_vector.cc
source/sundials/sunlinsol_wrapper.cc
source/trilinos/CMakeLists.txt
source/trilinos/nox.cc
tests/ad_common_tests/helper_scalar_coupled_2_components_03.h
tests/adolc/helper_scalar_failure_01.cc
tests/adolc/helper_scalar_failure_02.cc
tests/adolc/helper_scalar_failure_03.cc
tests/adolc/helper_scalar_failure_04.cc
tests/adolc/helper_scalar_failure_05.cc
tests/algorithms/newton_01.cc
tests/algorithms/newton_02.cc
tests/algorithms/theta_01.cc
tests/all-headers/CMakeLists.txt
tests/aniso/solution_transfer.cc
tests/arpack/arpack_advection_diffusion.cc
tests/arpack/parpack_advection_diffusion_petsc.cc
tests/arpack/parpack_advection_diffusion_trilinos.cc
tests/arpack/step-36_parpack.cc
tests/base/aligned_vector_01.cc
tests/base/assign_subscriptor.cc
tests/base/derivative_form_trivial_copy.cc
tests/base/function_parser_13.cc
tests/base/functions_08.cc
tests/base/functions_08_gradient.cc
tests/base/functions_16.cc
tests/base/index_set_empty.cc
tests/base/mpi_exceptions.cc
tests/base/mpi_noncontiguous_partitioner_01.cc
tests/base/mpi_noncontiguous_partitioner_03.cc
tests/base/mpi_noncontiguous_partitioner_04.cc
tests/base/polynomial_lagrange_order.cc
tests/base/polynomial_minus_equals.cc
tests/base/polynomials_vector_anisotropic.cc
tests/base/qprojector_02.cc
tests/base/quadrature_sorted_test.cc
tests/base/quadrature_test.cc
tests/base/reference.cc
tests/base/replace_in_string_01.cc
tests/base/simplex.h
tests/base/table_handler_10.cc
tests/base/time_stepping_01.cc
tests/belos/solver_belos_01.cc
tests/bits/fe_tools_09.cc
tests/bits/fe_tools_10.cc
tests/bits/fe_tools_11.cc
tests/bits/iterators_01.cc
tests/bits/joa_1.cc
tests/bits/parsed_function_constants.cc
tests/bits/parsed_function_constants_with_errors.cc
tests/bits/periodicity_09.cc
tests/bits/refine_and_coarsen_for_active_cell_index_03.cc
tests/bits/refine_and_coarsen_for_active_cell_index_04.cc
tests/bits/refine_and_coarsen_for_active_cell_index_05.cc
tests/bits/refine_and_coarsen_for_parents_03.cc
tests/bits/solution_transfer.cc
tests/bits/sparse_lu_decomposition_1.cc
tests/bits/step-12.cc
tests/bits/step-13.cc
tests/bits/step-14.cc
tests/boost/node_visitor_01.cc
tests/cgal/cgal_intersect_simplices_1d_2d.cc
tests/cgal/cgal_intersect_simplices_1d_3d.cc
tests/cgal/cgal_intersect_simplices_2d_2d.cc
tests/cgal/cgal_intersect_simplices_2d_3d.cc
tests/cgal/cgal_intersect_simplices_3d_3d_01.cc
tests/cgal/cgal_intersect_simplices_3d_3d_02.cc
tests/cgal/cgal_intersect_simplices_with_vertices.cc
tests/cgal/cgal_mesh_criteria.cc
tests/cgal/cgal_point_01.cc
tests/cgal/cgal_quadrature_01.cc
tests/cgal/cgal_quadrature_02.cc
tests/cgal/cgal_remesh_surface.cc
tests/cgal/cgal_surface_mesh_01.cc
tests/cgal/cgal_surface_mesh_02.cc
tests/cgal/cgal_surface_mesh_03.cc
tests/cgal/cgal_surface_mesh_04.cc
tests/cgal/cgal_surface_mesh_05.cc
tests/cgal/cgal_surface_mesh_06.cc
tests/cgal/cgal_surface_mesh_07.cc
tests/cgal/cgal_surface_triangulation_01.cc
tests/cgal/cgal_surface_triangulation_02.cc
tests/cgal/cgal_surface_triangulation_03.cc
tests/cgal/cgal_triangulation_01.cc
tests/cgal/cgal_triangulation_02.cc
tests/cgal/cgal_triangulation_03.cc
tests/cgal/cgal_triangulation_04.cc
tests/cgal/cgal_triangulation_05.cc
tests/cgal/cgal_triangulation_06.cc
tests/cgal/cgal_triangulation_07.cc
tests/codim_one/bem_integration.cc
tests/codim_one/fe_dgq_prolongation_01.cc
tests/codim_one/mapping_fe_field_01.cc
tests/codim_one/solution_transfer_01.cc
tests/data_out/data_out_base_vtk_03.cc
tests/distributed_grids/2d_refinement_10.cc
tests/distributed_grids/3d_refinement_12.cc
tests/distributed_grids/solution_transfer_01.cc
tests/dofs/block_list_04.cc
tests/dofs/dof_constraints_11_x.cc
tests/dofs/dof_handler_redistributed_dofs_01.cc
tests/dofs/dof_handler_redistributed_dofs_02.cc
tests/dofs/dof_renumbering_02.cc
tests/dofs/dof_tools_21_b.cc
tests/dofs/dof_tools_21_b_x.cc
tests/dofs/dof_tools_21_b_x_q3.cc
tests/dofs/dof_tools_21_b_y.cc
tests/dofs/dof_tools_21_c.cc
tests/dofs/extract_dofs_by_component_04.cc
tests/fe/2d_grid_projection_hermite.cc
tests/fe/assemble_q_iso_q1_01.cc
tests/fe/assemble_q_iso_q1_02.cc
tests/fe/deformed_projection.h
tests/fe/face_to_cell_q1_2d.cc
tests/fe/face_to_cell_q2_2d.cc
tests/fe/face_to_cell_q2xq2_2d.cc
tests/fe/face_to_cell_q3_2d.cc
tests/fe/face_to_cell_q3xq4_2d.cc
tests/fe/face_to_cell_q4_2d.cc
tests/fe/fe_conformity_test.h
tests/fe/fe_data_test.cc
tests/fe/fe_enriched_01.cc
tests/fe/fe_enriched_color_08.cc
tests/fe/fe_face_orientation_nedelec_0.cc
tests/fe/fe_nedelec_face_edge_orientation.h
tests/fe/fe_nedelec_face_edge_orientation_0.cc
tests/fe/fe_nedelec_face_edge_orientation_1.cc
tests/fe/fe_nedelec_face_edge_orientation_2.cc
tests/fe/fe_nedelec_face_edge_orientation_3.cc
tests/fe/fe_nedelec_face_edge_orientation_4.cc
tests/fe/fe_nedelec_face_edge_orientation_5.cc
tests/fe/fe_nedelec_face_edge_orientation_6.cc
tests/fe/fe_nedelec_face_edge_orientation_7.cc
tests/fe/fe_nedelec_face_edge_orientation_8.cc
tests/fe/fe_nedelec_sz_hanging_nodes_convergence.cc
tests/fe/fe_project_3d.cc
tests/fe/fe_q_dg0.cc
tests/fe/fe_support_points_common.h
tests/fe/fe_tools_block_renumbering.cc
tests/fe/has_face_support_points_01.cc
tests/fe/has_generalized_support_points_01.cc
tests/fe/has_support_points_01.cc
tests/fe/interpolate_system_2.cc
tests/fe/interpolate_system_3.cc
tests/fe/local_sparsity_q_iso_q1.cc
tests/fe/shape_function_belongs_to_01.cc
tests/fe/shape_function_belongs_to_02.cc
tests/feinterface/fe_interface_values_02.cc
tests/feinterface/fe_interface_values_12.cc
tests/feinterface/fe_interface_values_17.cc
tests/feinterface/fe_interface_view_01.cc
tests/feinterface/fe_interface_view_02.cc
tests/feinterface/stokes.cc
tests/feinterface/stokes_simplex.cc
tests/full_matrix/complex_real_full_matrix_09.cc
tests/full_matrix/full_matrix_66.cc
tests/fullydistributed_grids/repartitioning_09.cc
tests/grid/extrude_orientation_01.cc
tests/grid/extrude_orientation_02.cc
tests/grid/extrude_orientation_03.cc
tests/grid/filtered_iterator_04.cc
tests/grid/filtered_iterator_04_operator.cc
tests/grid/grid_generator_04.cc
tests/grid/grid_generator_10.cc
tests/grid/grid_generator_half_hyper_shell_02.cc
tests/grid/grid_generator_hyper_shell.cc
tests/grid/grid_generator_non_standard_orientation_mesh_2d.cc
tests/grid/grid_generator_non_standard_orientation_mesh_3d.cc
tests/grid/grid_in.cc
tests/grid/grid_in_msh.cc
tests/grid/grid_in_msh_03.cc
tests/grid/grid_in_msh_03_v4.cc
tests/grid/grid_in_msh_v4.cc
tests/grid/grid_in_msh_version_1.cc
tests/grid/grid_in_msh_version_2.cc
tests/grid/grid_in_unv_2d.cc
tests/grid/grid_in_unv_3d.cc
tests/grid/grid_in_unv_3d_02.cc
tests/grid/grid_in_vtk_1d_3d.cc
tests/grid/grid_in_vtk_2d_field_data.cc
tests/grid/grid_out_gnuplot_01.cc
tests/grid/grid_tools_05.cc
tests/grid/grid_tools_06.cc
tests/grid/grid_tools_collect_periodic_faces_tolerance.cc
tests/grid/hyper_ball_dim2_spacedim3.cc
tests/grid/reference_cell_reverse_orientation.cc
tests/grid/reference_cell_type_05.cc
tests/grid/reference_cell_type_06.cc
tests/grid/solution_transfer_01.cc
tests/grid/solution_transfer_02.cc
tests/grid/torus_01.cc
tests/grid/tria_accessor_neighbors.cc
tests/hp/boundary_matrices_hp.cc
tests/hp/crash_21.cc
tests/hp/do_function_derivatives_01.cc
tests/hp/do_function_hessians_01.cc
tests/hp/do_function_laplacians_01.cc
tests/hp/fe_collection_05.cc
tests/hp/fe_collection_06.cc
tests/hp/fe_face_values_reinit_01.cc
tests/hp/fe_nothing_17.cc
tests/hp/fe_nothing_18.cc
tests/hp/fe_nothing_22.cc
tests/hp/fe_nothing_dominates.h
tests/hp/identity_constraints_01.cc
tests/hp/identity_constraints_02.cc
tests/hp/laplace.h
tests/hp/limit_p_level_difference_01.cc
tests/hp/limit_p_level_difference_02.cc
tests/hp/limit_p_level_difference_03.cc
tests/hp/solution_transfer.cc
tests/hp/solution_transfer_02.cc
tests/hp/solution_transfer_04.cc
tests/hp/solution_transfer_05.cc
tests/hp/solution_transfer_06.cc
tests/hp/solution_transfer_07.cc
tests/hp/solution_transfer_08.cc
tests/hp/solution_transfer_09.cc
tests/hp/solution_transfer_10.cc
tests/hp/solution_transfer_11.cc
tests/hp/solution_transfer_12.cc
tests/hp/solution_transfer_13.cc
tests/hp/solution_transfer_14.cc
tests/hp/solution_transfer_15.cc
tests/hp/solution_transfer_16.cc
tests/hp/step-12.cc
tests/hp/step-13.cc
tests/hp/step-27.cc
tests/integrators/assembler_simple_mgmatrix_04.cc
tests/integrators/cells_and_faces_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_matrix_01.cc
tests/lac/affine_constraints_set_zero.cc
tests/lac/block_linear_operator_04.cc
tests/lac/constrained_linear_operator_01.cc
tests/lac/constraints_make_consistent_in_parallel_03.cc
tests/lac/constraints_make_consistent_in_parallel_04.cc
tests/lac/constraints_make_consistent_in_parallel_05.cc
tests/lac/constraints_make_consistent_in_parallel_05_nonowning.cc
tests/lac/diagonal_matrix_02.cc
tests/lac/full_matrix_kronecker.cc
tests/lac/full_matrix_mmult_01.cc
tests/lac/gmres_eigenvalues_02.cc
tests/lac/gmres_reorthogonalize_02.cc
tests/lac/householder.cc
tests/lac/iteration_number_control.cc
tests/lac/linear_operator_08.cc
tests/lac/matrix_out.cc
tests/lac/matrix_out_02.cc
tests/lac/matrix_out_03.cc
tests/lac/parallel_vector_01.cc
tests/lac/parallel_vector_02.cc
tests/lac/parallel_vector_03.cc
tests/lac/parallel_vector_03a.cc
tests/lac/parallel_vector_04.cc
tests/lac/parallel_vector_05.cc
tests/lac/parallel_vector_06.cc
tests/lac/parallel_vector_08.cc
tests/lac/parallel_vector_10.cc
tests/lac/parallel_vector_11.cc
tests/lac/parallel_vector_12.cc
tests/lac/parallel_vector_13.cc
tests/lac/parallel_vector_14.cc
tests/lac/parallel_vector_15.cc
tests/lac/parallel_vector_21.cc
tests/lac/parallel_vector_25.cc
tests/lac/precondition_chebyshev_07.cc
tests/lac/readwritevector_assignment.cc
tests/lac/solver.cc
tests/lac/solver_mpgmres_01.cc
tests/lac/solver_mpgmres_02.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/solver_selector_01.cc
tests/lac/solver_selector_03.cc
tests/lac/sparse_matrices.cc
tests/lac/sparse_matrix_tools_01.cc
tests/lapack/solver_cg.cc
tests/manifold/spherical_manifold_01.cc
tests/mappings/mapping_fe_field_06.cc
tests/mappings/mapping_get_vertices_on_face.cc
tests/mappings/mapping_q_cache_05.cc
tests/mappings/mapping_q_cache_06.cc
tests/mappings/mapping_q_cache_07.cc
tests/mappings/mapping_q_eulerian_15.cc
tests/matrix_free/assemble_matrix_01.cc
tests/matrix_free/assemble_matrix_02.cc
tests/matrix_free/assemble_matrix_03.cc
tests/matrix_free/compare_faces_by_cells.cc
tests/matrix_free/compute_diagonal_07.cc
tests/matrix_free/compute_diagonal_08.cc
tests/matrix_free/compute_diagonal_13.cc
tests/matrix_free/compute_diagonal_util.h
tests/matrix_free/copy_feevaluation.cc
tests/matrix_free/create_mesh.h
tests/matrix_free/estimate_condition_number_mass.cc
tests/matrix_free/fe_evaluation_shift.cc
tests/matrix_free/fe_nothing_02.cc
tests/matrix_free/get_cell_category_01.cc
tests/matrix_free/get_functions_circle.cc
tests/matrix_free/get_functions_gl.cc
tests/matrix_free/get_functions_mappingq.cc
tests/matrix_free/get_functions_multife3.cc
tests/matrix_free/get_functions_notempl.cc
tests/matrix_free/get_functions_q_hierarchical.cc
tests/matrix_free/get_functions_rect.cc
tests/matrix_free/get_values_plain.cc
tests/matrix_free/integrate_functions.cc
tests/matrix_free/integrate_functions_hessians.cc
tests/matrix_free/integrate_functions_multife.cc
tests/matrix_free/inverse_mass_01.cc
tests/matrix_free/inverse_mass_03.cc
tests/matrix_free/inverse_mass_05.cc
tests/matrix_free/inverse_mass_06.cc
tests/matrix_free/inverse_mass_08.cc
tests/matrix_free/matrix_vector_04.cc
tests/matrix_free/matrix_vector_04b.cc
tests/matrix_free/matrix_vector_07.cc
tests/matrix_free/matrix_vector_14.cc
tests/matrix_free/matrix_vector_14_notempl.cc
tests/matrix_free/matrix_vector_14b.cc
tests/matrix_free/matrix_vector_15.cc
tests/matrix_free/matrix_vector_16.cc
tests/matrix_free/matrix_vector_17.cc
tests/matrix_free/matrix_vector_26.cc
tests/matrix_free/matrix_vector_27.cc
tests/matrix_free/matrix_vector_curl.cc
tests/matrix_free/matrix_vector_faces_24.cc
tests/matrix_free/matrix_vector_faces_34.cc
tests/matrix_free/matrix_vector_faces_35.cc
tests/matrix_free/matrix_vector_faces_common.h
tests/matrix_free/matrix_vector_hp.cc
tests/matrix_free/matrix_vector_hp_no_template.cc
tests/matrix_free/matrix_vector_hp_parallel_01.cc
tests/matrix_free/matrix_vector_mg.cc
tests/matrix_free/matrix_vector_rt_01.cc
tests/matrix_free/matrix_vector_rt_common.h
tests/matrix_free/matrix_vector_rt_face_01.cc
tests/matrix_free/matrix_vector_rt_face_common.h
tests/matrix_free/matrix_vector_stokes_noflux.cc
tests/matrix_free/matrix_vector_stokes_notempl.cc
tests/matrix_free/matrix_vector_stokes_onedof.cc
tests/matrix_free/multigrid_dg_periodic.cc
tests/matrix_free/multigrid_dg_sip_01.cc
tests/matrix_free/multigrid_dg_sip_02.cc
tests/matrix_free/no_index_initialize.cc
tests/matrix_free/parallel_multigrid.cc
tests/matrix_free/parallel_multigrid_adaptive_01.cc
tests/matrix_free/parallel_multigrid_adaptive_03.cc
tests/matrix_free/parallel_multigrid_adaptive_05.cc
tests/matrix_free/parallel_multigrid_adaptive_06.cc
tests/matrix_free/parallel_multigrid_adaptive_07.cc
tests/matrix_free/parallel_multigrid_fullydistributed.cc
tests/matrix_free/parallel_multigrid_interleave.cc
tests/matrix_free/parallel_multigrid_interleave_renumber.cc
tests/matrix_free/parallel_multigrid_mf.cc
tests/matrix_free/point_evaluation_36.cc
tests/matrix_free/point_evaluation_37.cc
tests/matrix_free/quadrature_points.cc
tests/matrix_free/solver_cg_interleave.cc
tests/matrix_free/step-37-inhomogeneous-1.cc
tests/matrix_free/step-37.cc
tests/matrix_free_kokkos/cell_loop_block_01.cc
tests/matrix_free_kokkos/cell_loop_block_02.cc
tests/matrix_free_kokkos/coefficient_eval_device.cc
tests/matrix_free_kokkos/compute_diagonal_01.cc
tests/matrix_free_kokkos/compute_diagonal_util.h
tests/matrix_free_kokkos/evaluate_1d_shape.cc
tests/matrix_free_kokkos/evaluate_2d_shape.cc
tests/matrix_free_kokkos/matrix_free_device_matrix_vector_06a.cc
tests/matrix_free_kokkos/matrix_free_device_no_index_initialize.cc
tests/matrix_free_kokkos/matrix_vector_device_mf.h
tests/matrix_free_kokkos/matrix_vector_host_device_multi_component.cc
tests/matrix_free_kokkos/tensor_01.cc
tests/mpi/active_cell_index_01.cc
tests/mpi/cell_weights_01.cc
tests/mpi/cell_weights_01_back_and_forth_01.cc
tests/mpi/cell_weights_01_back_and_forth_02.cc
tests/mpi/cell_weights_02.cc
tests/mpi/cell_weights_03.cc
tests/mpi/cell_weights_04.cc
tests/mpi/cell_weights_05.cc
tests/mpi/cell_weights_06.cc
tests/mpi/compute_index_owner_01.cc
tests/mpi/compute_mean_value_02.cc
tests/mpi/data_out_hdf5_02.cc
tests/mpi/derivative_approximation_01.cc
tests/mpi/extract_constant_modes_01.cc
tests/mpi/extract_constant_modes_02.cc
tests/mpi/extract_constant_modes_03.cc
tests/mpi/fe_tools_extrapolate_common.h
tests/mpi/hp_cell_weights_01.cc
tests/mpi/hp_cell_weights_02.cc
tests/mpi/hp_cell_weights_03.cc
tests/mpi/hp_cell_weights_04.cc
tests/mpi/hp_constraints_consistent_01.cc
tests/mpi/hp_constraints_consistent_02.cc
tests/mpi/hp_constraints_consistent_03.cc
tests/mpi/hp_step-4.cc
tests/mpi/hp_step-40.cc
tests/mpi/hp_step-40_variable_01.cc
tests/mpi/limit_p_level_difference_01.cc
tests/mpi/limit_p_level_difference_02.cc
tests/mpi/limit_p_level_difference_03.cc
tests/mpi/mesh_worker_01.cc
tests/mpi/mesh_worker_02.cc
tests/mpi/mesh_worker_04.cc
tests/mpi/mesh_worker_matrix_01.cc
tests/mpi/p4est_2d_constraintmatrix_03.cc
tests/mpi/p4est_2d_renumber_02.cc
tests/mpi/p4est_save_01.cc
tests/mpi/p4est_save_02.cc
tests/mpi/p4est_save_03.cc
tests/mpi/periodicity_04.cc
tests/mpi/petsc_01.cc
tests/mpi/petsc_02.cc
tests/mpi/petsc_03.cc
tests/mpi/petsc_bug_ghost_vector_01.cc
tests/mpi/petsc_distribute_01_inhomogeneous.cc
tests/mpi/petsc_step-27.cc
tests/mpi/refine_and_coarsen_fixed_number_06.cc
tests/mpi/renumber_cuthill_mckee.cc
tests/mpi/simple_mpi_01.cc
tests/mpi/solution_transfer_02.cc
tests/mpi/solution_transfer_03.cc
tests/mpi/solution_transfer_07.cc
tests/mpi/solution_transfer_08.cc
tests/mpi/solution_transfer_09.cc
tests/mpi/solution_transfer_10.cc
tests/mpi/solution_transfer_11.cc
tests/mpi/step-37.cc
tests/mpi/step-40.cc
tests/mpi/step-40_cuthill_mckee.cc
tests/mpi/step-40_cuthill_mckee_MPI-subset.cc
tests/mpi/step-40_direct_solver.cc
tests/mpi/trilinos_bug_5609.cc
tests/mpi/trilinos_distribute_01_inhomogeneous.cc
tests/mpi/trilinos_step-27.cc
tests/multigrid-global-coarsening/fe_nothing_01.cc
tests/multigrid-global-coarsening/global_id_01.cc
tests/multigrid-global-coarsening/interpolate_01.cc
tests/multigrid-global-coarsening/multigrid_dg_periodic.cc
tests/multigrid-global-coarsening/multigrid_dg_sip_01.cc
tests/multigrid-global-coarsening/multigrid_dg_sip_02.cc
tests/multigrid-global-coarsening/parallel_multigrid.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_01.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_03.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_05.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_06.cc
tests/multigrid-global-coarsening/parallel_multigrid_adaptive_07.cc
tests/multigrid-global-coarsening/parallel_multigrid_fullydistributed.cc
tests/multigrid-global-coarsening/parallel_multigrid_interleave.cc
tests/multigrid-global-coarsening/parallel_multigrid_interleave_renumber.cc
tests/multigrid-global-coarsening/parallel_multigrid_mf.cc
tests/multigrid-global-coarsening/step-37-inhomogeneous-1.cc
tests/multigrid/mg_coarse_01.cc
tests/multigrid/mg_data_out_04.cc
tests/multigrid/mg_renumbered_02.cc
tests/multigrid/mg_renumbered_03.cc
tests/multigrid/renumbering_05.cc
tests/multigrid/renumbering_08.cc
tests/multigrid/transfer_system_01.cc
tests/multigrid/transfer_system_02.cc
tests/multigrid/transfer_system_03.cc
tests/multigrid/transfer_system_04.cc
tests/mumps/mumps_01.cc
tests/mumps/mumps_02.cc
tests/mumps/mumps_03.cc
tests/mumps/mumps_04.cc
tests/mumps/mumps_05.cc
tests/mumps/mumps_06.cc
tests/non_matching/mesh_classifier.cc
tests/numerics/project_parallel_common.h
tests/numerics/tensor_product_creator_01.cc
tests/numerics/tensor_product_creator_02.cc
tests/opencascade/stl_refinement.cc
tests/opencascade/stl_write.cc
tests/optimization/bfgs_05.py
tests/parameter_handler/multiple_parameter_loop_01.cc
tests/parameter_handler/multiple_parameter_loop_02.cc
tests/parameter_handler/parameter_handler_24.cc
tests/parameter_handler/parameter_handler_29.cc
tests/parameter_handler/parameter_handler_3.cc
tests/parameter_handler/parameter_handler_3_with_alias_01.cc
tests/parameter_handler/parameter_handler_3_with_alias_02.cc
tests/parameter_handler/parameter_handler_3_with_alias_03.cc
tests/parameter_handler/parameter_handler_3_with_alias_04.cc
tests/parameter_handler/parameter_handler_3_with_sorting_01.cc
tests/parameter_handler/parameter_handler_3_with_space.cc
tests/parameter_handler/parameter_handler_5.cc
tests/parameter_handler/parameter_handler_6.cc
tests/parameter_handler/parameter_handler_6_bool.cc
tests/parameter_handler/parameter_handler_6_spaces.cc
tests/parameter_handler/parameter_handler_8.cc
tests/parameter_handler/parameter_handler_9.cc
tests/parameter_handler/parameter_handler_read_json_06.cc
tests/parameter_handler/parameter_handler_subsection_exists.cc
tests/parameter_handler/pattern_tools_14.cc
tests/parameter_handler/pattern_tools_15.cc
tests/particles/exchange_ghosts_periodic_01.cc
tests/particles/generators_14.cc
tests/particles/particle_weights_01.cc
tests/particles/property_pool_03.cc
tests/performance/instrumentation_step_22.cc
tests/performance/timing_matrix_free_kokkos.cc
tests/performance/timing_step_22.cc
tests/performance/timing_step_37.cc
tests/performance/timing_step_37_gc.cc
tests/petsc/index_set_01.cc
tests/petsc/petsc_snes_00.cc
tests/petsc/petsc_snes_02.cc
tests/petsc/petsc_snes_08.cc
tests/petsc/petsc_ts_00.cc
tests/petsc/petsc_ts_01.cc
tests/petsc/petsc_ts_04.cc
tests/petsc/petsc_ts_05.cc
tests/petsc/solution_transfer_01.cc
tests/petsc/solution_transfer_02.cc
tests/petsc_complex/00.cc
tests/petsc_complex/vector_equality_1.cc
tests/psblas/find_psblas.cc
tests/quick_tests/mpi.cc
tests/quick_tests/step-petsc.cc
tests/quick_tests/step-slepc.cc
tests/quick_tests/step-trilinos.cc
tests/rol/vector_adaptor_01.cc
tests/rol/vector_adaptor_02.cc
tests/rol/vector_adaptor_apply_binary_01.cc
tests/rol/vector_adaptor_no_ghost_01.cc
tests/rol/vector_adaptor_with_ghost_01.cc
tests/run_quick_tests.cmake
tests/run_testsuite.cmake
tests/serialization/discrete_time_01.cc
tests/sharedtria/boundary_dofs_01.cc
tests/sharedtria/limit_p_level_difference_01.cc
tests/sharedtria/limit_p_level_difference_02.cc
tests/sharedtria/limit_p_level_difference_03.cc
tests/simplex/alfeld_split_01.cc
tests/simplex/convert_hypercube_to_simplex_mesh_01.cc
tests/simplex/hanging_nodes.h
tests/simplex/orientation_02.cc
tests/simplex/orientation_03.cc
tests/simplex/orientation_04.cc
tests/simplex/periodic_tet.cc
tests/simplex/simplex_grids.h
tests/simplex/step-12.cc
tests/simplex/step-12b.cc
tests/simplex/step-38.cc
tests/simplex/stokes-sv.cc
tests/simplex/unit_tangential_vectors_01.cc
tests/simplex/variable_face_quadratures_01.cc
tests/sundials/arkode_03.cc
tests/sundials/arkode_04.cc
tests/sundials/arkode_06.cc
tests/sundials/arkode_07.cc
tests/sundials/arkode_08.cc
tests/sundials/arkode_09.cc
tests/sundials/arkode_10.cc
tests/sundials/arkode_11.cc
tests/sundials/ida_03.cc
tests/sundials/ida_04.cc
tests/sundials/ida_05.cc
tests/sundials/kinsol_06.cc
tests/sundials/kinsol_06_v2.cc
tests/sundials/kinsol_06_v3.cc
tests/sundials/kinsol_08.cc
tests/sundials/n_vector.cc
tests/symengine/substitution_maps_scalar_01.cc
tests/symengine/substitution_maps_scalar_02.cc
tests/symengine/symengine_scalar_operations_04.cc
tests/symengine/symengine_tensor_operations_03.cc
tests/tensors/symmetric_tensor_47.cc
tests/tensors/symmetric_tensor_trivial_copy.cc
tests/tensors/tensor.cc
tests/tensors/tensor_33.cc
tests/tensors/tensor_complex.cc
tests/tensors/tensor_float.cc
tests/tensors/tensor_trivial_copy.cc
tests/test_grids.h
tests/trilinos/assemble_matrix_parallel_04.cc
tests/trilinos/assemble_matrix_parallel_06.cc
tests/trilinos/mg_transfer_prebuilt_01.cc
tests/trilinos/precondition_amg_dgp_01.cc
tests/trilinos/precondition_muelu_dgp.cc
tests/trilinos/renumbering_01.cc
tests/trilinos/solver_control_06.cc
tests/trilinos_tpetra/add_matrices_06.cc
tests/trilinos_tpetra/block_matrices_01.cc
tests/trilinos_tpetra/precondition.cc
tests/trilinos_tpetra/vector_reference_01.cc

index 60afad616836d9e24be713c9111c44a840a76bf3..f31d5139fea76142873de5ff9841f3fff6e6006d 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2023 by the deal.II authors
+## Copyright (C) 2013 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 4afc00efc26e9a4ac01023a2f364e8c0545a57d4..896e056c08cff160d6a6b8f85a4ec1ad066933de 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2024 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index fea8f9687d3567a7ff6b388706a77a98b858ed59..bc6b5b67bbb9dcf0c0850ed7e477f25d02c1434c 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index aed9a7377802a82d52a2ef2e5f7e6eaa917cda05..b7e8d65cf6d46415cd34449367c74b363a612e99 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2022 by the deal.II authors
+## Copyright (C) 2013 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 5ad6b6ce1743012f5b078471584adfa270a94584..1afa5c7014cd4d562c59643784ddc4245d834458 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 80289f21a88b28ea66b3b586a69d16e7896eb159..5faeaae0e4e1a87bee03fa19fd4309e5f90e7751 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2023 by the deal.II authors
+## Copyright (C) 2023 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 3c447fdb1c981fba084adf194f40a3a868d0af09..9e5f608b8fb236d832e46d51118edf35dcdc6c36 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index bb979dc9802250dc454874443da3cdbe2f66b02f..904a4e6bfa41e7782d7df379a19e32870a31f78b 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index fee8811229d2f2aef6746da7f49838d21c03c66d..e247721afeddc045139435699e602f2939804330 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2024 by the deal.II authors
+## Copyright (C) 2013 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index b74f6530f132bb13bc0a2e64e463f7ff5da2112c..eab6efa60e2f660ca0059be5e2fc41080af2bd53 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 6c91802d424960bb5539401ad888745f4f9477d5..5cacdfadfd84c7096586f07032c73d178685c9ce 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 51c15adb9a75f041eb0e9995b2d40d9a74038ce4..139a6c9e37823297abb27afab779e5eab28e6863 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2024 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 43f9a0b6fe05c55892ab507b7fbf113e4cd59b39..686ebdf4e68faef43cf2606060da1d9a7f706c9c 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2021 - 2022 by the deal.II authors
+## Copyright (C) 2021 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index b838da6b781104da74f583874fea911d122c4fd3..cda15f741c5854d19fb2bc3b94790cd557dee657 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2021 - 2024 by the deal.II authors
+## Copyright (C) 2021 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 46a6fe5b5bed6a4e683a278366aabb94d47535fe..13cc35f81d0f0c01b6adc0c9baa852fed4179ec3 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2018 - 2023 by the deal.II authors
+## Copyright (C) 2018 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 0310523425d03bd8fffd2c6d8e936d04f7b42397..206caa83406cc975a8529284fb69562ab2dc29c1 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index e4e34a794ca58678c5a5657af469876d163aa845..a74f767f90a09ae2220de829be3a1ef28ba87e93 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 63cbc85f92cf76dd96fd31d29857ff29700076cd..1f63b040fc6a0a2d07393324059640464ca00a32 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2017 - 2022 by the deal.II authors
+## Copyright (C) 2017 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index cabf4a69c48db831105c96a35e51d164ef19ecfe..8bc17133eaf21bf100ef9f1ccdd49a7e87f46a68 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2017 - 2022 by the deal.II authors
+## Copyright (C) 2017 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index a30b1338f5d53f8ebd722991ad99104efc64efbb..823fb013a430bf3a349ecf81653b9501f0c4a333 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 5ec7c394a1dee22be3a59b9c7d5fdc6999308560..e64741726c17572aba91408ab72a787d49515665 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 3e370d943d8ed1672c08ccb31478e8c7c836e0a1..422a4939351dccb8a538707e350fcc0ecd84cd44 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 11def5959d99c5e8d2c56db66bd811db8a393bcd..47ecb22dbd4b8158d8c6008624361d931797ef96 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2014 - 2022 by the deal.II authors
+## Copyright (C) 2014 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 030278aebd1b9d43172d9f11d66efac542ff6588..94ed2b59d595299fa556cc6c11e94c01eacb516e 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2022 by the deal.II authors
+## Copyright (C) 2013 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index ac1abf0669baf90c1d93b2654a9a0b2c021e882c..026f4d94651abc78ab632aa12968ae87df41ed5a 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 8485816d8d4e12bf6ca4c982afb4c80bca2ed383..b24264ab581d0133ef842ccda43882fd1e0df455 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2023 by the deal.II authors
+## Copyright (C) 2023 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index a82e4dbc8a1d3207b06d1086fc34971fa74399c0..48f6cbaa8b6ac55c006fd747f979abc99e712e97 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2024 by the deal.II authors
+## Copyright (C) 2013 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index e248b61f14b32a323ba400f68fe36ae41e4e839d..9440d9fbd8de04728c5309122302de32c8b7bf6a 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2015 - 2022 by the deal.II authors
+## Copyright (C) 2015 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 44b243f0b08db42629cf196ed63cdb3c0c2bcc02..71878e469247a2e24f5a6abccee183f4ea9a3b30 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2024 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index b031599c7f54f1272e1119767f911441328008ed..904d2ff679b1d5952553ddd352f2d4886d5d5f96 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2023 by the deal.II authors
+## Copyright (C) 2023 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index de5e571709d1450cf16a78bd30dde85eb693cdfd..18929a3a0b4ea0e66dbcfae09d61ba063a7737e2 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2023 by the deal.II authors
+## Copyright (C) 2023 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index fe0e4b69c266c85cef9efcc27942c028a7a8078f..273a1bd2d3a4c489d71dba71122521be35780393 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 0bca643405ceff3c340df782a604c4730f1516e3..093298506e934cd059bbc4035cdc42e52abc6b32 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 198ce8688cb1dcfd8742a81d8e5fc2494d299bfc..b7c57904c24727668a78fbc900cb154b74c0f28b 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index bb5295ca6e706137f71a07cf8dd8b05f6723251b..aecbf97351caf5d6e230f01fcbb8eca8e16849fe 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2023 by the deal.II authors
+## Copyright (C) 2023 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 3f629c62fb2d6201081718e7df9eb627a8a624da..20c6f0db0ccd34cb71b490a176c0ae85457e48fa 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2023 by the deal.II authors
+## Copyright (C) 2023 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 3289786763645368832a3ab9eb30c582ea164d25..9a135b646f8f8fb1fdd67176741faa700c65336c 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2014 - 2024 by the deal.II authors
+## Copyright (C) 2014 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index c82f7ec28b9a2f84b775727cf5f9145f3e47c41c..eeda21011ec10af141b62674ad102b4b86fccedf 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2022 by the deal.II authors
+## Copyright (C) 2013 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index bba80d7ea51efe1fe9d9870b01b74213c40f2a22..622c5daaa5940f181a6453e254c2e1e05d5e7b25 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 15e618bf2ee83aaa97282176b7b2d2c4e55154a4..ee40a93d88dc4577467e4ed1f309e14c762be094 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2023 by the deal.II authors
+## Copyright (C) 2023 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 9e0ba9b927cdf3eea7327a948c0af0f56dc83c97..5ea3402db311369f9bab8c6b58cc92d563ccf6a2 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2023 by the deal.II authors
+## Copyright (C) 2023 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 5b2893aa1fca1ac2bfa45cb3ed6708218fcfe624..1f60817e2dde188d3ea40473e36f06159db9e7eb 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2023 by the deal.II authors
+## Copyright (C) 2023 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 01dd55db869efe90156ef82ebf00ff1f458169b0..9a933e1e660459e423dc54f649a5a61781a690a5 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2021 - 2023 by the deal.II authors
+## Copyright (C) 2021 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 1fbe664ec3732840df59f6cbfebbb7e1c1f57ea3..c2d7aa89ceed49d646b7b83ae153491e8717abff 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2014 - 2023 by the deal.II authors
+## Copyright (C) 2014 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 39b7aec339dd25867b41cac8dffad28d01eec5b1..db2f8ba0f005d085aa3641caab14068b1c9602a1 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2021 - 2024 by the deal.II authors
+## Copyright (C) 2021 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 220cfc7b726557cbf3ca0d1f0fcdfd6243db833e..9a2d5e329d0265dcf634a655f7efb266aac8a675 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index cc75eb022330e75e5a3354feb5890388ba969785..24174d793a2465ffb01875194b053a341abf7c9f 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2014 - 2023 by the deal.II authors
+## Copyright (C) 2014 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index b864fdb05ba932cbf17c7cb497c8930b6c5e9a44..cd2fb7eec8e16665a17a2046ed9cfff2920ed6a4 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index c945645a16b3d771073c2d2bbbe08db95e379d77..e5976d0a865b2b8715b26f1a617b065199428e39 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 874b332286f104762d8bb8152847c016b826dce2..34f1476ad7a30ce3a1fad6a9471d098e274eb4dc 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 33c82e0ea7d326447a39c31296f2a028b84a23b2..0ca3002fa72c378ddfc3e4f2198c351de4ca1182 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2017 - 2022 by the deal.II authors
+## Copyright (C) 2017 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index cf6ce68fdcfba411beee80cf06ba8f4ccbfca420..94d043f8f4c0ef6d01eb3e94c4858b46a3bb719e 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2017 - 2024 by the deal.II authors
+## Copyright (C) 2017 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 7ff28686dd97a982c673a96ed19e2925fce6355c..8fdee916b03b67e8ce2b19b12dcf9fefb6d35070 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 02c3bb93c09b5cb40d5ce419edc44503bc4f737e..8d88180ddc93cf53e9871e53f400d669f94ae9d1 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index eb2d5957bf50062d63cb0b86eb518911ff4daadb..77e3b144649fef1fdeb3efce9525044d59aad438 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 22d0f597670e1fee8095f0df493c0d7dbd30ae10..af05e14ceebdaa0eea24e5b07b8055b9d553a681 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2024 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 8108cde40da895dab0f2c2c06005b835c825da34..c419d5d59e92f5bc8b20346bb22481fa5cfe79b6 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 373bb0aca882084ef66087d2f9919a9e3107af91..839b916ad12f6c270361fcc43853e5d5b69cf4db 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2023 by the deal.II authors
+## Copyright (C) 2013 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index e4c05850b05dcb7578b0bd6f57046ee07678b7aa..af130b14f10b0a8ba9e377eaf753eeb48dd3c516 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 632b74775ec7715989b2f66261011edc99a7d4fa..b8992dd6289ea8c1361de7ec504a954789396c3c 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 7074b10469ad36c6ed23ce4f835d8f3500ebd53a..c03ea4f91be77598e4ba754b6bb29febabef64bd 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2014 - 2024 by the deal.II authors
+## Copyright (C) 2014 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 334c76595f60869223c8987a62c8b86462198234..1c5c56a94065df83702eeceb2f8da076530589b5 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2016 by the deal.II authors
+## Copyright (C) 2016 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 573d3b3ecb2c87e5c38afbf57fdc20dd211aab11..7935473bbdc3752cf16464a01b16a52b9fea2a46 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2016 - 2023 by the deal.II authors
+## Copyright (C) 2016 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index af16af5510ebdf22493c166ef783842f3ef0e227..f023324843f609e23e430e081773ce35cb717817 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2019 - 2023 by the deal.II authors
+## Copyright (C) 2019 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 0881046ec1790be0ea05662a1399259f13d541e3..19239878a589bb02c6ff92712eb6f3e94e6b077d 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2019 - 2023 by the deal.II authors
+## Copyright (C) 2019 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 812397375221b072f6394951c34349ad136eb39d..dd244dfccb76822e01fe60f753de7a897a402fff 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2016 - 2023 by the deal.II authors
+## Copyright (C) 2016 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index d674cae48b653d6cfce554e417bcc15c00729579..e716364dc9bce7bb15453777e6790496f10e03da 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2020 - 2023 by the deal.II authors
+## Copyright (C) 2020 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index e26991cfe7f7c6381b0be63006c08a0129a6a14e..03c39ff1dcb8d0f3c8b95185ea501510ba2378ce 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2016 - 2024 by the deal.II authors
+## Copyright (C) 2016 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 0cf670f707e57d3f19e288d449d4ad7b33ec0ef4..f847a479792eb68f91260224e49cce041d362751 100644 (file)
@@ -3,7 +3,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2014 - 2022 by the deal.II authors
+## Copyright (C) 2014 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 6db1ae46ecb0503321372a73f24dcdcc3718e1c9..72710e44221b7f580e26b35a15de9dd6e392cec7 100755 (executable)
@@ -2,7 +2,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2019 - 2022 by the deal.II authors
+## Copyright (C) 2019 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 47a9ec083f6b270fdda389ff662212a6aa47069e..e4ad7a6827bab7d77c7f779b36a04684715385ce 100755 (executable)
@@ -2,7 +2,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2018 - 2023 by the deal.II authors
+## Copyright (C) 2018 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index a111555c2297c9d833fc0bc728580216778727b0..0be31aa9f0864d273f9e8e7a4f6f827bda39174e 100755 (executable)
@@ -3,7 +3,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2014 - 2022 by the deal.II authors
+## Copyright (C) 2014 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 90b8e3ae44e8b005966d59ee338ef3103399275a..f99abf0747a076c1f77fd737441467e131d83623 100755 (executable)
@@ -2,7 +2,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2018 by the deal.II authors
+## Copyright (C) 2018 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 342a26fec311931ddb702a40a02616ac05abaa93..1e93e6057bc0aaf6319d7c92af4b858cea965a23 100755 (executable)
@@ -2,7 +2,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2014 - 2024 by the deal.II authors
+## Copyright (C) 2014 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 38963a8df96a6db13383bd36ff90dad4e56420bd..0975acc85c408f21c31c25e4979ff54c17176249 100755 (executable)
@@ -2,7 +2,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2024 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 6b799bf9bf05402dad22933899da5aa5ed321a4d..e485e0d97e7a7c832e3f8f2d90f44e58f5837ad3 100755 (executable)
@@ -3,7 +3,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2019 - 2023 by the deal.II authors
+## Copyright (C) 2019 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 40004eb06a2bc84dca2f05252f881320c9e4c59d..d8683ac2d012d1b6449472903a4928186772ebcc 100755 (executable)
@@ -2,7 +2,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2018 - 2024 by the deal.II authors
+## Copyright (C) 2018 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 7f71d21b5c1f0e7197a4954957b5f6ff09c92664..3463e6bdf29da7d1565e2d9af56009f197a2c755 100755 (executable)
@@ -3,7 +3,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2016 - 2022 by the deal.II authors
+## Copyright (C) 2016 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 8b616c9ccaf4f4f18b5c38e93f37a3e03db70217..c07faefdb65b538d14894c075b1a451ed119c3d0 100755 (executable)
@@ -3,7 +3,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2017 by the deal.II authors
+## Copyright (C) 2017 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index ebf9c8527e24d3500308a3f066b7458d1da3e8f8..7277a3d64abd86cc199c6cdae8b1c2902705d6a9 100755 (executable)
@@ -4,7 +4,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2016 by the deal.II authors
+## Copyright (C) 2016 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 6af4ed0aacbf2fff0433ca6e6e2e283216374a85..e904798687557a6c313dd09ef2fb0bffa90ebfee 100755 (executable)
@@ -3,7 +3,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2016 by the deal.II authors
+## Copyright (C) 2016 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index df8837fa7847534c4aa9002dab621937b63fce8f..820f760d1d6095132d0874b3e0d75872399d7679 100755 (executable)
@@ -2,7 +2,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2018 - 2020 by the deal.II authors
+## Copyright (C) 2018 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index d0216eb4f2f24cabbcb181436a2ca9b5babca66e..7620e4beff681a8ed802322243a93e4047f1a62c 100755 (executable)
@@ -2,7 +2,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2015 - 2022 by the deal.II authors
+## Copyright (C) 2015 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 2ceeade67aaff282d041eae02bcdf1e8587a1c4d..437a2406915efe741a574bdaf4fb84b92bef8c42 100755 (executable)
@@ -3,7 +3,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2014 - 2022 by the deal.II authors
+## Copyright (C) 2014 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 7236f8cbd427d57929b7388d3e7b0dfb37f36a14..dcb21ea387adc0018bd5a06744a5d54783fbdc27 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2024 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 3e08a6a4a8327b0ef472026463e692208db09e6a..62777582115720d1a2d4cd2f24f021ac23c73696 100644 (file)
@@ -1,6 +1,6 @@
 ## ------------------------------------------------------------------------
 ##
-## Copyright (C) 2015 - 2023 by the deal.II Authors
+## Copyright (C) 2015 - 2024 by the deal.II Authors
 ##
 ## This file is part of the deal.II library.
 ##
index 7194277f94affb8783f80bfee8d1c3467d95c2ed..be3e942685def4d1ad01e5db629c83034f7c500f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2023 by the deal.II authors
+// Copyright (C) 2007 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 72cdb699a7faedd1fa1c748625bd39d7b291410b..b983f67a2f98320c92f89038daa662e7bf1156de 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 692552e17fd51950e3d7634ebf932c79c3e63092..8c30f72cd141a62a726a71c8f15f4ef8561fbcb4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96c16d85e8c028e2f44b46691f66584862bb9e29..b29b75a2cf459ac440ab283d21d24253fe1a6969 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47cb8a9e6f63559a005059cd38d527bf8a7edf3a..c87d6fea84c3deaadc7da832235eea309a3d7c5e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2023 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8562a615a1d73f7ea32dd59813c7a0e0e03a5c0b..2fa82ecbe529aec3d37a2a7a96af67b4d3624c07 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e7fb81903b09c755de0ecfd8f578d6ff3f08d78..8c180b5155a30cc8ad14218b54047d2ccdb745cd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2020 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8fc5fbfb748aef0406de1b1260b97e52d6f53044..269578407cbe5e3bcef46b232a3ad37799ebfab7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 234b44c4419c7e1c1f58f5a85ea09761188dd319..6b3f387af31439233d38cea351f835187ed0d9d1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2021 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cdf0486d61c9160b3b06b229d8b11985c9462b82..2cfa2c565eb02d140edbd8c47ecee8c4a7c11555 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47b2804a10aa28c051dbfb8833e80c9c55027f6b..98198c657784559bb8139bd9429acef86ecdd86e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2022 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3597a98871db08984b84599a0c76759dbb4dc97..0fee82274fe7991f182213d2b9eded7c67668b2f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2020 by the deal.II authors
+// Copyright (C) 2005 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb001a6479f4887209a8285a21defbd2525fd60a..579f865604f69aae78be9dbaabc2105e9fa2ca06 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c30bf1eae2e83fc828eb15ce76b5e178b95889e4..5e7cc1923cf88e0dce888319ae9e6f190099ca5b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2015 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8460cdf4c2fb956827e6f0c5e99acfdaddf17149..4af77c940c2ab88ec905371d1ef5d79523066ca8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2021 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c8fa2b3cd60a0052730bd0c446d1f9c12684821..245e4431e187901b2759477f1c9ebf81c176e881 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2023 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a932e4591f9bf34db76755eff6d41fd6af55476..75a58ea891efab40cc236a70efb9050aa3b55486 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2022 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c43ff9ea13d66fa13b494ba5e10f7a12e78193e..29bdbdb4563c79785f451ad89a0aeac2c1e244e9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b7bf9afc60369dbcb66f5841b4b92d8870d5797..086c8fc343b54ed4fffcf6e8f9e5de01c5f2d6f0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e94df1e60c9ed9df3aa69b365931d5e9ff7b0f8..e404f3de73c55bf4c2c7114ab3bd8a75bd588524 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bda5c87b0f61977dbd2888c70f4ecadd3253f632..136ad527e5f9e012681d608ff0d0603970acce79 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2014 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94d90b052a7ccac058a29933b7afac1f19881906..3461448332ae56cb8c14c7769c25bdf363f58ce0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2023 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25664ecddd82022c9987081075872a315ce6079a..f5f8591112b16d6fa2d1020c841ff210d6472b23 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 26f997f17e302c4844498566040479efbbcf2d4d..514e8639b1c5d423526a70280c70c1efcce60b82 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2022 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1efc711ba5089e52d5fbd683410293de810f606d..c743fdcdbb30ba05a61a19f6275d2e96ed7f633a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2022 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48d6958eb23c25e8bdf125e6b8a06bf281f0feaf..62e68ee5f8b60a62cf3c7c2a7d1289213207e5da 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2022 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1879892e1af6386b844cfaeaf7036db200a4e538..0617693054dbc05cec88cd043c9b2934f6e626ae 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 650f10a7d35ffe5aecfdcdcbbe75fa0158cfc856..d8fc793e9a7e3ca94e33c9ea9498aa1bd892c826 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2015 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55bd82d51c4172f625ea71830cc29219665684ca..4593dc900dc0bbdfca54b4b326d10eccd3d37fb7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2020 by the deal.II authors
+// Copyright (C) 2005 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97be0a700ffa561d4531158cc262739251af8c94..f943fe45c87044af004a7660ec96ab94510314ac 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 179d23d93e44ab27b0d6eae8d555164d8ee3b414..460f1c1ea30faa80cb3f7eea8add5b5f3d06c2e2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc4e495f4858497ddbf61a181da5d7d1c7307527..0574e18b35c192a286af16e089c58ccea43494f8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2022 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 664b432cb8cdbe6d7d078cf05f0ad372072a273c..c2b2ccd94265657b8b26782529cefc55a5ab786d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2ade1d47a5d9567084d92544bb94d4e1422dde8..28c1769bd16b35d60680811db9a7505e0cd247ef 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2022 by the deal.II authors
+// Copyright (C) 2008 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4641bfc9fe0d2961ca93e2f17cbd233f3d20bc10..dabe7693881ebe9baeb4f55da69dde1c0e64c2e3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 257c6435708f320988d3f478871768ea81428ea7..1467d64008ad1a9fdcaff7633ba9b9b232427448 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79312a1779b21a615487e7b491313614c4bef30c..e11e52ed4397624c60975a3272b258e71104f129 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2016 - 2018 by the deal.II authors
+## Copyright (C) 2016 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 341c90be36f3c06f24e615d21ceaecb8f82c32e3..3f5d9336257036de98535d2c621f50ad741f35d8 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2023 by the deal.II authors
+## Copyright (C) 2013 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 3662b3a087baf19591a26b5248c070f3ee9a6129..94af19645a3e514ab50a2d63d4f94c2fe3234f27 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2023 by the deal.II authors
+## Copyright (C) 2013 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 3a7ceedd032d11d995cae27a387d3d824689ecc7..eca5139d6b436a76cf1af47e68aedb5975b9b332 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2006 - 2023 by the deal.II authors
+## Copyright (C) 2006 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index f36263113f89e316dc78f974bfbe9bdf6cbe1e3c..a59ef5b5844fb3ac071452d56711cd8f5c290d93 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2009 - 2023 by the deal.II authors
+## Copyright (C) 2009 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 6fcbe90971286897421a43bd4ccbfc940fc28ae2..382963f61dcc2b5661ea6ca65461177b88a8c0d8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a0489df6deac8042ee64f3ecb61b375d672e5eb..8c6e3bfad36f12a0d8e2d62522e2a2f04388d7e9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dffcaa9eefe24b7e12f7c4182024ae1e41450938..6e8dc26426c5be605c402e809b5a5a53c037c27b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf1648724ccf41ca30c115fdbb9064cbe510e40f..20eb2bf6e5c4a80490fcbdb744bbdfabf6ad0221 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a6dddc369c6bb36c913f73936d962f8e1bbdd17..7eeb1d646982f7d8e26bb367523975ba3be0f302 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b67811d4b410f8f46c392d44782ea0378c5b643..36f3c8f3ad26dd797949fd672e6d3f8c19c2372d 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 8ae303f1640eba3ef6ccc582833b025ef4d7c727..ce7ba1de15c421d4fc6003cb280f023536d6951c 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2001 - 2024 by the deal.II authors
+ * Copyright (C) 2001 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 688c756660baf0eaebadbf1d655ee8dfe359fd91..769582abe75cf10f796c2c0996b84282255dfde4 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2005 - 2024 by the deal.II authors
+ * Copyright (C) 2005 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 2bd5406143d22c96da2a71ddaecc960e7989b68e..a43d70d5a5fef3fbcd73dc281a3ca74e770e9d52 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2006 - 2024 by the deal.II authors
+ * Copyright (C) 2006 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index e0d3b0d3ed1bfafd5a0502f90e22f09cbeaa5424..8627f1c1f7fac160f30c58b9284e10e12170b2df 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2008 - 2024 by the deal.II authors
+ * Copyright (C) 2008 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index c85b25dec60a358808c058ae693d985f00890606..878b80983f63491fbf65bd3b7b9ac119bed9a599 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2008 - 2024 by the deal.II authors
+ * Copyright (C) 2008 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index ebf438940c74ed0e02a839b9d63ff7c6f3d0a583..0faaee6173980ba8ba68ef620e4e1fe57cfd4cc7 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2010 - 2024 by the deal.II authors
+ * Copyright (C) 2010 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b594c115d2e9f3ca8f40aa386df3e46947ef90ba..9ed9e7fe5241965272f861d31c1f13e5d364c872 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2010 - 2024 by the deal.II authors
+ * Copyright (C) 2010 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 1866f46475c121d1cae1019e69418f3c6e51c54a..cf1598485896463e27bf148a78b57039650d014e 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2012 - 2024 by the deal.II authors
+ * Copyright (C) 2012 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 6e20db98671322a75cd6a3d9b035d9787f96a258..dfeb205f9feba2c03e22f91322d8ab5f3b853119 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2010 - 2024 by the deal.II authors
+ * Copyright (C) 2010 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 270fec16067ad365b33099b3f69cfd540f5882ae..3b51623cfc290f0294b9bbb31b33112e27406db9 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2011 - 2024 by the deal.II authors and
+ * Copyright (C) 2011 - 2025 by the deal.II authors and
  *                              & Jean-Paul Pelteret and Andrew McBride
  *
  * This file is part of the deal.II library.
index 1c9764a3bbb0131cd9bfe83cc039bcfd0d63d1aa..87be93e8c92ddd25b4d34a360bc1fb2d80575ad8 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2013 - 2024 by the deal.II authors
+ * Copyright (C) 2013 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 365b10a3508a9638399125585bb79c9a82d1db4e..0b8dcc4b7a27865cc55d172ba8649b9de8ed7ce8 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2013 - 2024 by the deal.II authors
+ * Copyright (C) 2013 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 5080ebe3b5d44fb0d38da45560f4f9d96bb1684e..608a96df45f3df4b64f44f3ab00d591fb5ba36e4 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2016 - 2024 by the deal.II authors
+ * Copyright (C) 2016 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 7a5e658474a08b79115ea320dde5b0dc7526099f..efb126752e5a35f1e6845a3aadb8501b71a2fce5 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2019 - 2024 by the deal.II authors
+ * Copyright (C) 2019 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index f494ab9a9d5c856a32f69ba4a64ad355c0321cfc..d94eb8ef2f8638e51410be9ffd57e09a42528961 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2019 - 2024 by the deal.II authors
+ * Copyright (C) 2019 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index bae77776fb0c3fe9910218a6024b866f55b202a7..83b98defac2f3fa94bb5e83086dd8d83dddcbc95 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2020 - 2023 by the deal.II authors
+ * Copyright (C) 2020 - 2024 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 1e3125e52d1963b33406c8ab04293b69224d6538..33b5b44fe1da24ccf2b1669d9c87fa8049156378 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2021 - 2024 by the deal.II authors
+ * Copyright (C) 2021 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index a30a7be4ed350d96dd56e55f2ebd20239a6edaed..a8d3389eb8fe1e557709b529703b40ea2740b963 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2000 - 2024 by the deal.II authors
+ * Copyright (C) 2000 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 0ddd7cc55743ed1a22bb9e100d379310bce9e3bd..c9ad176c06173b7dd947c98fdd0cf38bf212760b 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2022 - 2024 by the deal.II authors
+ * Copyright (C) 2022 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 8672bda7895485cab61b3cdb7e91788476018193..4cc16e141e6ef9406d549472a165401a7eff3ada 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2024 by the deal.II authors
+ * Copyright (C) 2024 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 3c0da0b526c53f45e572fd72f07d2abd1467f406..f7b73cfd2434a574a9fe793f57cd16d45b8f15de 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2024 by the deal.II authors
+ * Copyright (C) 2024 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index ffc637f83649bc48f831d926795d4303a5504bf8..638cba09f658a67921f931889144cb5ed145a4bc 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2024 by the deal.II authors
+ * Copyright (C) 2024 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 6f3cd4bb41fca95763edfc54877d8c77d460daa8..e7b1d421af9fffefa88d24873b7ed12478028105 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2024 by the deal.II authors
+ * Copyright (C) 2024 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 123db6970ba65ca1a898f4e1876310ea112b7daa..5e847589da4af7f6eaa49d5f0d950ef358b03567 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2024 by the deal.II authors
+ * Copyright (C) 2024 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index bd8d0fda69b0c150baaf11df2d0706bfe13a7770..463de946724d9942fd3c299bb2bccd15c7c516f7 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2024 by the deal.II authors
+ * Copyright (C) 2024 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 6166c79146962b44a2da39c719ae8a8904a7e788..57ca4baa6774ce8be3589bf41c3d09b1b5af96f8 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2024 by the deal.II authors
+ * Copyright (C) 2024 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 66188a8a5b40b5cb0f3748e7dc7b43f8b99df03d..9312a86ff4a1cb407a10c2faa40388fcf6855c87 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 03bcefa9582a6aa388364c3519d1375baa1299ac..9a2e2677ee99fcc0c1c2fca95ec90f0aa5743b8e 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index e15308d21f77be07ffc52bcf287494de78b76465..152507c070af28315d2521e84f62d2efa27dadd5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2024 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea3f6b9265cc53b64e3285e4404ce468f0fcbf75..bf13811d5497998f518d80453ce8f85d62863f2a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34fa83e6106732ad1ac5c24ec4c1bd36d0f61e9f..f192019aff900864b62b8d30c8c025ce7e6c71aa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2020 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ad60b1cfeb7f933a782167e6bb7fc731757ce72..7fa88bf3f13f97b930d6999d563f831d75fdea24 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2020 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 269749d9da51a78642db2ab574edd3604a15e300..35d47e327c832f32329d1d991396e5f92497a824 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2020 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4e1589fefda97d36fcde101b34535800c541393..d027f91a707f1c9202c43ddc3df0fb484f845447 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57ebf71a35859bd6a29ce76d2ea075106eede955..a6d8d9c9518a87b91074aab76abb7427201ff808 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6819cdd6ecad76a0e1e7868a70b57fa03dc099da..e869803c2f82b238d78e88021ab6d6d5f5c346fa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c98b41798268597e1ac17fae8c690f55e29b1dbd..595f2f13572c8fa3a98b900605f80e239c51c7bf 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2022 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 152c25c3eb16d467b17e0e14f772186c8f330c68..8f094272169e47c3b8430abe06e3bc98b815e7db 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2024 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 010e6b7a2b65721a5198a6f55a3b706c5b5a2a0a..598e8a715d3355a2b81810fbfbc078e0a1768849 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e5d95e47747774b276a1b439534294c951248294..a61555e7d6add292b95ee3ccab2f0e78b5b1330c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0009637f65fa3ab6cce4a72ed6b5056e018e6453..1aacea509f1a7276fa47b0a6545eedae612dccca 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 766648ef2341ef10cf8e4856af546817b3cf90e1..79f3cc8b2e71d10cadf85a3ff63a5743b6e75342 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84080691766e537f201345363fb33d605a20da4a..759ca4a36d0dbd1949af343c2e81f4bd376f6650 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79937fa06d36bb0e10dc238a70d7458c1230dcb8..d65343432c66ab20458cf60816c520d090cf9fc1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b17047e64db6fb74a53469d7fd5229ec2fa24f50..54a7e3dd6fce27a37e8b7af657babf154a8fd4c3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d8c9367fdedbf503668cbe273a2c23cb7ccdb0e8..5c96a64be74e84ae1f3f4bee1b58f8108513a21a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2022 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb82b4b4a2b04bf465c602e7290f53a2e6a8bdae..6e19b5e66b5ed927fd428e1d9b5bf8503093ad64 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e958bb583fc298ebfe30708c68dcc34b473eda6..8f4c05eaf100ca42af7597de54c1611a5c851f46 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71a541658dc854f4c650aef9071fafb67ff7ffdb..d72dd731f59392f4964ad49ffed4a86716fa1567 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index acb9cc0072b496d357ea74f9ed841218e74fcb24..baf74601c243bcfbcd5b418ce4aac0d992fd6da1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 371946e42fd0dc28b1e1f2daacd738223f92e904..282c0de753ece39dee93d81e597bab6e6c2e7e37 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6807dc184e154be3959f34345a50575ae538caf8..971c149efbed52e3517d6f1dff6aca5afc2e1bae 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8ac2f09f75bb0473df15e3c1f46aa6733076278..7112f7cb9ee90dc64ab5f1082b0898b679024583 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6afa9a8a8259154668ac0a0bf44a714219d3f2f..7d7ac506ffcf031f1d29bacbde0520ac3a86e6c7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2023 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da0c93d54dc27a44115349abc6798cb599db3494..c84c0ff5c2a6b0dbb17fa2567b4343ecdce19211 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e53514c383d481084074d8b05af10e269b7dab5..b811ff47499a7ea43ff14e40b8b492c010d1f7d7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 162adba396592a0ea7905df5cb4d385c6095f5d4..f70bc932b9b6a198e7f3d516a4fa75e08b5a7630 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d581fb663aa0ec8c59c1aceff5bee3e101f1268..01e2f945ae05268fbf283fe75c4399d9b9660585 100644 (file)
@@ -2,7 +2,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1eb2cef7bfab6c8ab9e5b020fe29665818afdb1d..f89323eeb1f2f371562437a4fe48e94b60b4295c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a2ff05797e8bc854e72445d768d1216c49a2b6a..83c07a9d839293f7d72d5d65cfb7f7951fe0898c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2024 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6e5617c9d173abda479c4c821466e72543705aa..1a37df4e712a4364414d054fe0ccb121fd3f3ba6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1471639a3952d3b165334ce070d80c7f61871a18..6227aae09dd02cedf81a065dcefd13e1aff3285f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ac0cbc15d2f1959d82423eff29e9198b46fcdf5..72cbe7b2bfaa812133f83498747c35cdbd0e6b18 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0762378bf70be681034fd916f03c4c6d8c490922..93df52be95b76f2aad66b666c52297a4d225fc0d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2023 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a4a3050d4bdcee44761c3f7f908202eb1efec48c..235e5fb4a107517b09970dbcd74d2d4a39fd4959 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c126e9ff4c96b80655d5dbfae37ad5dc43e9bbe..8481930f31e93bd9a28d4d666ef7e86d6947d5b0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db0fe4e275b7c954b844c9e3ec53d6635d1ce0e9..58a4623067b75c2c956936ba154bad7f709ab98f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d40c494b34b437f6f708f83c14687aa9504325e..559293521d070b029a27a94897a08dc969918690 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e827ee4773999506002d023ce5b251aacb10642..c90165d01c23e998f33cbd986984ccaa304509e9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b92864c979ad46328d75fb2cfa17645761f1370..fde8b2670a81188372edab746816e59b28b52443 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 565b52ae37b854a8c3c47665aee228c9eb8c156b..a9a91243e7defccfae4d86e2dfd96b449aea3df8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2022 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9706cec3bac51fe5d85a6296da221e05ff19730f..e8ae5f41b60e4935491237ecc566797d4e32d2a0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b721166c1d3e44033b630191f1c52d62079280eb..863ea2ff7f31c2935a99170ebb560f717c4c5e3a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cfc0dd0416a7347a7a453e3abf22402f77f43dce..c9f3ad89923490722734401005388498a291fe5d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c934e29d4d6069db76bc846bacb8d96c5d0d1383..eea5be9d948b622d2a29820dc3c37b0cfdc3b515 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d7ffc0b3e0cfa05280dfe68ae58673feb8ec58e..c0b82207804a1d6d7451616f2e7b8248fa664a53 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a1de9fae7fdfb6626b9668799590cc87243a3956..cced8c630f9679b18ef6e5736db9900327595a73 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2021 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c7b460c449227095ca31385c41d9c44bf59eb456..ef767d383e80692e75d7e0acab0b61260bd16994 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b2c2d282e327cae1746c42d57b84bcaf64587c4..07d1832d89f8410147bca76e1de43b4ed486c131 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2024 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63007a4dc9a07039635846cd61c96d59a0a51c14..aa599412f02a1883a5b55be30d9d8912dfa73a07 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb131b2634b5ed188b8a78741381e68ae9d41a8d..506d4cf13fdfbc7b03d423e1b75a61f985e78e1a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2024 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2a39ed4331553f614b6af3996027fa0aafd1981..938c9f57ebc938080a28580d55ccee3ab82d4005 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c8fe573a9431310081fdb73ded9a7a69543237f..16f276def85f993311c4a95575ebdaa3845713d1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93f75a85ac333073a4b3d84bf4a29493b5edc2ed..32924013d04b49c745ea1dba4827b5ae10b103dc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b3578d06b702cbaacf0a1253398ea0104590242..cdc09ea3cc4648625591a693133c7343d0535125 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2023 by the deal.II authors
+// Copyright (C) 2007 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 24d36efeb5e4d1ac0abfc5a3b6ff50167780f196..c49dec756caf3b40bd2383417b77e6b4eb323f33 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0f711f887f77233703acc7a7b8d59aee1ee6ee2..7503ace7c4476094cfc82c09efd38486dcac0aed 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1bef499dbf8ad96ae3107c9549d0224f7dc29053..f329eba307cd8264480f389dc4038335076f48ea 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cacab306da715a1b4235766eda53ac15ded3bd32..3609d39428a07344579c66a2ce80dc2fd253858c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34e5e4c61ec814d0a6392c1a0c4ab623b5c607d6..952744591c6038a4ff1e1db05ec36066ddb714d8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f8d803e3655aea151e3388858501a8290a62b3f4..2dbcd16ea65ef677b1d789a57f299a21dd70262a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ea759f59e29d2cf97b6f9936a25ae6459d26b13..c3228c3af7968bef4fd2aa826010dbf5e0fa334a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2020 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f40ab42534ece6c566ed8d40864b5688828ed81..76f5b3f76dfed1b77e9d5028fd474c5dcbbffcae 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 063cdbb22ffc6c0d2a696a2d268ab2700ee78a20..84c10ac369855f23afafd34b58b6e1958195e14d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e9fc71f4a749d4884dda3470f50b47662641fec..7a17edb9572a9341a21ccecbaa6fa5b2c09e403e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81db2436e8e4168884d649cd752d7f401a3cda13..832ca5c7caf2591d92730f86c188721270579672 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a08908c2191d71ac744f5df425fe4810495bc2b9..d126f23e4812d289ab3479d3cbdbd050d69d8bd8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0f0a6fe68ee1a25b95bf792fddb8db2406e0ca3c..c9cbb50d9b67206c1bfc6dd01407ff38e3d4a70f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d38cdf8e3b3737f1e12251a568134831076f4abc..5e2f834d375f4c87b2841f1ebe63bc9e22549876 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31b28534df42d0d8fb3caf383495400fba5dbe02..faeba9741fbe1eb599ceb1c6d3415c93f0038c96 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91a26b12679ab679a4d08a2c620f56bd6a1594ab..0a067d66c723cc6df4912eb1c1a3794beb0457e0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba1aad7e9de9cb8a8c68518c3d7078776e36d14e..50ef29418abbf53c23a1edadade5eb24da1cbef2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c99fbf57b9527faf0a69e4c7ceeaf573a232e9af..95596f9882225761d25dbf3ce983d2d86c3f6a49 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2017 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf58df7662ce71d88fb9804fb2363be2a4b9f427..b3d8639f5c1af68405e01d02de44d15b60b94604 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2c5056493fb1fecddd532e57aab068b5d0b8ce1..da18c20da1a779804160c472f73de8254e9c63be 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab4a6724bb65bb081dd7058fcc3be7e623179ed0..e99b219e3e69b22e188ff0b50a428f4b641f0c2e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ce4ed8bd0eb223e9b6211cb17635ab1c5fe4faf..ce10b0994207643c34d1f65a1afb35924694d983 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf247bc2bbf33a673ad35fb3296f51a69f6ee4e4..6bb053e06b3adb5fb22aa42e4c4158ec11ffaa18 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd9bc4478f6c827769f106bba5d26b6a36ea7655..8091f8857d150d5068a6ceb9c921cf215fea04eb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aff8aa1f8e3303eb794f01f8552941bb193b4528..9f3d7153cc0830060ffadfce91102cc396a0355f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f383f9f6487ff70ae714e31f693bde1e73abae2..a1615afef72b00dbbe191803b9393fdbe436398f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0756675f9319e290407a98c2e9050054ad7ac8b6..3e06f6b6ea98c4fc840719d8e70970e547e38a7c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b54b715939c8f638480747c1bb3db694ba1a7e60..88c4d50a08a6df9d2ee8f302766a5c33b194648b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be7af821b3602840b1037dd72b1c7642dd4f4cce..b924ad404c9dcb6f2aa60a37c1f6babb89ab6fd9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2021 by the deal.II authors
+// Copyright (C) 2009 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 78322fd176abf739793fc9d5e058a00afa287e00..75da467baca82a0f82d7b8942fdca50715dd8862 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2024 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bcaee1907694951e5fc023e42c5a111c81b03f0a..c4ff70452a0bdf5cc4a219b78393d60cf50d2c56 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd262f778d7649923b6dcde084a4a7d09edf2918..bc3af3ca244faba5fa63aa645b79503b84ffb8fc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2024 by the deal.II authors
+// Copyright (C) 2003 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3370bc30463cf81d2e3e80f0051826f45cb91a18..8e7297ee49b2f70b1bc6a17f316b28e12bfea139 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f18eafcb9adb1b5c99ffc36a5e74094db40c6016..40fa87c46465631acf43d686a10f96a6374d44e0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ecc957299d2af22b40f4d51679b22734eef8a84..5644577f1223fd40e60707815d21076fdc69f6b1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32364ddcba2921c2c0237a36cabdbd05ddc1d786..8df38c5414e1416c8972558e1baa43cce219779f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 114d98ec8d6be03ba56d518822350c67c6c38e67..0b486898c1a2cacc239d2b23bb44ddca571e8758 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d381ae3f81b6f8d414bf387bd5421a34dd007dc..a60d8ed0f1bedabee0e184740510a324cb3a76fb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b52064d1ee0ae156ce048661be7635f55739afdc..4330ee6b012a89186f76c0b0210eec3489bf4f55 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 286930552bf869500052211b851e8cb0ea29152a..91ec30cc752e11eceeecda5fb776c04e4db18730 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45cc723c650a321924fe072b62a2047d605722eb..8a0c5d454ca18e59552ea1b3bfd89b3b446328bc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2020 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98be5360d1645701b48ad8185f04174bc3165330..b85684f800bc5a19c4f400023c053292e0b18c55 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b37d3b6d4c74b836ad3fdc69391d0d4a113c6ca..68179bf4d58345e806018105d48045f5d6bc8574 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2020 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f7fa3f49ade8766a5b90d82bc3224a879ea8a690..3caa0f30bef456065c732e56159a346924402967 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c62bc450d82759399663e3b294262c675168a99e..42e8f40c53648fd16b9ec724e58f529da1fac4d7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2024 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 324bdf56f7540cd19c3d7629fc1876eed1110073..f7465309453977f5bfc0e0b69faa9d0abbd4e5ff 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1429cc5108c1e08c5f0824efee56fec6e967a1e0..a3f587713af5b4e68bfa95a094d70c19abd80b89 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35b88e1120481a8baa0a74896f2223ed041fd97c..8b8a9e9bc5a458b891683a6a8d3e30def3bce072 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 435d614f38c4912ca4b54b7499161c9b6e489ea2..607c916daab3a94aacce516db2e8b86ccadd30dd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10e84737bce8a1d2d36f5a8e0825bb0e31de0a3d..53a2554562d8daf4dd1064c6f307b1d2066a8536 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a73f4208ba5918caa3231909c16dd826cd979bb4..e8c3c350cf6924a43d4f52b85c9b9ec212e9f2c8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 43909ef61e96966f2a118f6a6b13403316ba5d16..86afe9ac261fd8c6fd331f8cc6a0453e11ed673e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index abb225f986bc1c36f1e52b092539812d031f7003..b00d40978a98149fdb5fdffa18bd32c25352a553 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9dd2929bf41227a616e910358c6bc8068d03d5f3..c15b2640a1901ab8e7ce5d680f27f7a948dc6d8f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2022 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a9e028f4a3a9b9798fca0057f2a67a5842e65a4..4dfc4879580f3e6e74d9f888bb9d84b7db290060 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f200d09d44e4a9d8e6541a579bc84847202488d..5d6f65c131e1c49ede62e6ac062714b26754374d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9c7e1adffba51462caff54aa607515aef816093..98bdcc8c740c3b010f0f43b5c9bfec4f57f4ede3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2022 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 696b8f7f8d24686b5d85b6afaaa695ddc5746334..ba1b8628373b342d3e454bf8a2318cf0c7b009b8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0fd0768a7d62ca4c6dae4fa6811e9b66d7f954ab..9d47e54bd910511b788733f9c3f4ee608847c769 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68b85a2fe62a5dc6eef25ccacccebf3033b104d2..1efd4d78c7f5b6fdc8c349f7654abe93a2f3f7aa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2020 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2cde6f4e38504189cac80380ef168fbb2590274c..855109ee71968222e60158b2cecf52751c5e8c36 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 389aea6b0cb9f89aa4a1d3085b20959e8d3b78ed..0c72639d5a7f9af16f6a29108b2f490f273c35dd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2020 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48933c47119b5b7eaffe5f155ce806bcc5522dd2..49a4f099c28ae31f564ca69d1ad383c76f5de862 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 108c4d56ce348368c93f8c6932fa56ab175e091f..237b3b7bbe7fc19a0533fa1e3a888ba8efad35e2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8eee93b683b11113e6e792833510cb5ee943a697..529d177478a5e6a35d589ec84d4ae05d60ddfc9f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d79ce546857ab6a65f4db112a0078bac3638f03c..dd06e6fd95e258cf4af2ede290c5ccd057cdd1f4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f39392633e92c8eeb8953fa3a3a2166379a12546..04361cc29852815cb2193d8b7efc6f3f67105628 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c657752d574093991c3624d192afc323f81811fd..8e1a64c3a6230a90232e94fe00b8ce164d4f0f92 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2021 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03f0cb5f4fc9141efd08bc59b04dd9f2a8c8a5ba..31c71e7effa490321dd19a0d146195336794140c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8bc760f2552eec71bb4c9699845db2084e30486e..e7ee50282bf831b24cbcec902f18220d2e4dfcea 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4e9438107a7e48b56f465c6e01b2ece5a43b649..0275a7cabcdfb4f412dcb4ee4d4d379be27ce84d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 164da5d75d69e4bfb5cb1822de191da0936e301a..5b394d3551fd192690e227513411796c3beb5615 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c7aba1df5f9819012e8dc51057e00281dce90ee0..c7557bb114a8464563d69b08efbc35c9e24c1299 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db980b02b46782643b1756dd506f98558a6a3f37..dd64788a1f60e39b5a67e7da87cb3ae32d5192b3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8b4d14d8b0e830ff81ef614d02bf11566b00e5f..e5750824a0286cd4b0667d17e5a0851a1e282148 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c730fb074100496baa86b1ee1272e16a9f15372a..f5dd2b59298a67aaed7d8356b309ace2baee6b40 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f53f33bdadb6e6875be6997919f2ea71e5c90f00..5c6f51ac4e00b9ff1ac05b5015bf8e3c52cde415 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d46cddea92b8544056150c6113b0aec22efaca5..75554b79fde278b8b0b2d07c0a4b08f57002635d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 00bcb2d29134606d7a9eb8f0312b227a79c08467..1c3e888ae3f7523cd8befdc45d6176d53a312050 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07e0ec96cd84d683603c2522c8eac808c0ed5839..3ca0861a9fac965cc086e9d7338be060333fac30 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16f31d6d4cd57e39b8f2a872aafad0e9fe088288..181677f57c172f0cb0a28a320cb97ac300c8d7eb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8e30969067165def913a6ba65ec8d2dde327ea0..b08da011809507335e25bee45e893002fd97087f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2023 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4b59dfcd3880071e95476d0e402565c83fcd343..149247833f6f3391f128e5d59366ed1385b3777f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e0ab93ee8886770a4d2d32814e758f9fa95d7d95..2edfda38e53addadd1863fc812bafefca3349241 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eea2858e0c9d1bb8894bf32e13d8399978069ebf..66fa252f68c80f9c1b4a729f2ca66fccc0b257c4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f3973c0346cc2a934b4d1dc391aa4c430edd292..8129cad5cc59942c654cf80b844c5c3744aafcf9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 188b2d177157d8643f993c77e422d05fc6ec02c2..c4ead83105d5ae33c5922b912d2ef30ce9803224 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80d2884951e08fcbc8a72b3995c5497e731c5af6..491eef46b4422900715376cd0f5c4fd3d551b9d5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99a5cbcaa9575867bff2a6dc026967d1c5be45a6..ea6e029a6144f93fbec3d3b7418e7bdecd75535f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2022 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81b8b1492274e42ac67add66529693ffa5ec5c40..46143eff57fee53b05545ec5f97e90484b999ab1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c52c704018d10972d93300d2f15fa061b909b441..b0c0006750f53096c361f38635967e8c61a4ac76 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e7d74645ff7e62ab4087552b9c177fa809ff01e5..3cb4a5352147b1c5850fbd27fe32e0eda32704ce 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 078cb14ad9dd611225a643a3e15a292666ab43ff..5a5a2eb6ed7f58985e14cfe483c9bb65bf93b14c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b31004fe73c804d081e48a107933cc178fe0c39d..1cdd173b5aa588967e1910f657e5bd750ef5955c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4280e2575616191418f8edace96867fcd826cefc..0604d673d4d0bf28e47d048ed1eb654457326aba 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f9dd84858d8128de1ba5c28767f42cadc6255b1..67b24cad508640314838c570ce0f7f24eb3b887c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 153f89d29c428441c0f53d66558ed77c4a627c60..2fa8164e2e930558d2199b87776ccd6c3c929f54 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6016387a562e012382978403837b791db8433d2e..86e8cabedcc10155d6f5c3ab130c1cdecc6b44ab 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e463240c38423d9a4c7b69090f4f98ebe66d0c18..2aa94015ed15308d40cddb5805d7933f17c03e00 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4bb6cd14cb9bea436ddcbef21aaf1bcc187c8fdc..79505ba85b37a7113b0beb60a2d5491a755ba1cd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b854ac5f467e156c7460096b57ee5192611a4d6..0a8ec26971976ed560ee3d4dbea87b58a6a69ed9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 420be5f268997d908ca096d42f2b617f500b7cca..96b65463dbdce749f0470e67fb7e4bd4b78a0bfb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25e4b2a81d3725adacb61e2ce911b59fef2cae68..9db6d5ca91025544cca931ca693b936804cf1bd5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e88d7a794d02ceac21fc57a78bb10f6d9efec35a..6d3effe5c825097ee4525292b532cbe79c54443e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ecd0aa9d3f10dc34ad15bbaf9dc1ae4c8bbcb40a..23a8cae2d2e623cf842369f9b0efc2d0e3ede6cf 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 142bcde1255852eb376994104285f7c6cea5d4af..67e07c0058100f6b141330ba944733590f9f498f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df8d567f859bbafa5e4e7b834cdd82329f3e9802..5481d7c3ef653488b6897a00749c7957187815ed 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 165ffa8ab70b74c082c4cb393da963cedaf84577..6183737ae3047cf3655d04a60dba1c9e95ab952f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f20180df8751552737c700aaa30c0bc7a56cfd6..655ec182143ac3edb0d19ea06e2157e655b82bbc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3c22849d4319f4713115a800cf4c7f462a6f47d..6de6178e3b71411f0c584f96018b1652dbf3561d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 202aba571c6498cf9f3626120d273b30949bad33..a49ebd7e9cb39fb202865cdace43a4857e6d9b48 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97ee33bb6cff15e462af158f826d6859ef77259d..a9bc1629d5045c91f5aa202ef598447f0e4f0e5f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe4a6f91c4c2e0dd2b340dd13672746d3553a555..98ccaf96b051024d359f231a14a6c58b759a3135 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2023 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6fda1b502cf5a8579857ffb8da00eeb9e6b5e742..8feec44e74512a4ab38b8c46c736daeb1b0cbf90 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4f2c47778f13fa226c81a197e2eb490e0fdcefa..434927c352166359d1ca8d6583c377a429c08ec4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2023 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38e5fb02af44f5a8029eacfb11201ffc90aab68a..22f4be6423319209fd581e9515199f54000264e7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5e6770e465f6d95883e8223df0656f049778c07..290d105b661895c0bb083c58ab64b0230c4a74ce 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f71995b420db61bf7cd5883b33ba8bc2c9b05fb..be093d68ab51689c0ef41aabe31036f7a1e8f3be 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f66d8306e1b5a50750f3ac81d732374e72a9cdd0..619931ecda4846dcd42b1547d6d8f5f9a4f38031 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e2b8f266ab5ba27aea2deb174ac7a3cfd730ae7..6b55de858cb81028a6c5aa4e2beacc21a9088ce6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b903472286481e512a7f5bbd7c57d5d49a9f2282..361c7811faeb81992fda80dff01387db15194201 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2020 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98a74449ce98672a1ad3f6c702269e161658b0bb..dfb0fc7a3bacc2959b2dc22f6f6a350e08ac2d8c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07aebd7fb2c1da9d94aad1ecc35185e207f1377a..329a289491d9e14f865986412a2cc2967e84ab93 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2543f4da5fc5782afc8881dde45511002cea050b..45669b492909784a2a7c978f3c426f8bc30c687a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b165f6c0ea40df54af97f2418c55dd0a09127dd..d0ff1bd8cf862c6f433c18b7d539c172b83eb353 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79941f36eb1b6d76e3ee35404d90ad636e591617..06c08ce780ee55e7ad703bf53bb9cce69575a0a4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59869d166b6e9183c254c63ab392b5edef5f6221..cc6699edae33bb4aeff8fcf74d268a7d4af14f6d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 53a8e585f5c0bf15c3e08536720c3c937c2f0602..42a5d78255c4254d3833eb787e38b1b3e585808e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 01995a8d9a041e89a810a2e83822fe5521e4140b..51fe8242269d87f964fab13b62226fd0d8d57ea5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a7b67214c9b0365be490df4ed459bfae7b54bd7..318c091bc0558f4c18ea38813b48fac68250cbcf 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 324461d5c069625febcb90e9bf121a905d0e4968..3602a76e3a4ff5a79fc1f2bd69738fc9f9f9a486 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2024 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9546a4930fd30069e80b990e79d75989206dc7d1..c01c6b88bff1f557556808c919fa71c971c0e81a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4bffedd58b053c542ac4b54e8f9260d2c9c105b..9942b135f5d9faecf3e5036e495cf453b33faf33 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7cf46b6066ec31915f4b88ebdaca87859636d18e..714c95f925593015edae13e70f31f6d4ed1ffe9b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 687b0c3d2ef2769b1c40e5541ddea451aa9befc4..d882f1741ca2851b1d357e04aaa1ea7b8dc8a371 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff258784fa36b44330fb309b24168f4f470aa014..41f84e202ccfd6df711701068185dc7961b990c3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 729f8c3fee23de1bf0fbb5176120be45f8c9d896..9a07c045fa30a89f5154173485fd0bc6a4f58a3c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4089f513106f2e7a8a82c374bdc9cb99ae47f03..8d0222edfa1e3be942b1dc4880d848232e04002f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 43f1e6f415ff282e91068ca6f3bcdcad3a727c6b..714454c9575effb84a422a92d130f5398675cd5b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c31bf891b21c9627d06c237116bac3f58276ec5..565a226662d4e346b03e15af0f8ef0f65aa81aaa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a2a270be973c1c0d0621ab4630745f2a8ed7f69..72b50f9a27247f51329e12e126b8e0dfb59b5a69 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 910ead95f14b9fbb56aba1106027fdf34ea28363..97dcecb2ae7e71c2335841743347ed2cd66b0548 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55eb822a796d5066072f9467fb562e0126f67f51..355a3e582667fd53dda0c7329393a9ef4426dbf3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a43bbe78b4ff1adc7fa9eaf44646bee63ee53367..d34e857eaad2f29e5cacda0d45f0842b7a40d7e5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b645c89a2e8cb9aa828cb7b94b7a6ffe95f2bf4b..639fd7469931bbc4a2f40bbfb940b50bbd73bc60 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5705c5af8f6a0252399b0b6cc349bc80b5e6726e..7e189962c4cc7aa5d29994f519ea6fd1c6721a95 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4430e7bc94a3f3eb2da7369ad71f8e37516ce09a..1f1eac95995015b008a79c4cbb9ee30209412e08 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59e1feb88d632925087d99bd30c7721b7dc44856..c661df3f38935040ab7bb3003dce08bc0e5c58ab 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66a015dc2130d83991798c4ed8dc3a8e722cdc53..36354fa3136f0c1ab721123a5527383d0bd723a6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cc8bc889c231a163a1d179c4a2835f9a1d085cc..1df392d9fb35f4c42dcdd5f7de2b8acc871cf054 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 20dc26828b658eae9c6b5b9cd8431fd6ebac4876..4f48ec247b916c98eb997f8cf98f4899dcb7ca4f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6aadcf2c9a78280d3487bdb1f27a93514c10be59..95a8de18165636b87ec04443e03cf8a0c7c08f6f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d8ecaa60833511dc89d253a932cdd35a1085401..c7c0d37caaf9b09f8a7398b4791652ba858a1588 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2023 by the deal.II authors
+// Copyright (C) 2000 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c80494a39d45abc070dbca5095753a11f2f46e08..8953e130ffe3efe52e4e7a4d8ed7600b2026ccc6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b6703f7f79231268035c50b288950eca7393b03..8f0d00618d32403f6f2cf640ce95c7ffa6897c32 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e3be0e48c68144b9807468dd21ab7dcc453385a..6cc94417643f82454586e1f790b281838af9c462 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b370f06aaa4bf851f714c870f554edb9cbf374ff..d0d26b16c80a14b3b8da468fa992a47c3a0aca6e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81919f2de68833e057a1743c448578f6edb4011d..c278276b4affc6e4a80f0a4ce2168e0f3ad3d6b0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2024 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 526d12f24afd24aace7dc4aacfd952260d535a4f..119db5220873222d8083ad255db7b9336d273620 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2023 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f3449ad56273708f3bc07aa0f82e773cb12f62e5..58b9e8366894c1122725cddf742de14687d0b752 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2024 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 312032b6754ec5f1ccabe9f5eb6e803f0012e9de..c676be2f8d9ffbf136515716d988172b45ce7142 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2022 by the deal.II authors
+// Copyright (C) 2008 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 459d2ca0d09c9adc8036a01b11b64035da65d5e8..3e7aec77a3190c75c70ff652bc5a0e14fcab3e52 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 683c62ae64a8e3d3e34cac021795ec1079698726..a5bad339acaa2cad19a52cf560ad271f18c6902b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e5be710bd153477f58c3b83ac5825e724f4ab83..1c31c8b30b36330dfc750b8f054ca3a0f177cc10 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0fa1269a1099ebd9cbcc5f9d0e90863e8fc3dd76..b3183f2920b424a8c1cd60e2e7d9681b27e42492 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2024 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39b1d2df373024f097123fb30cb28833cc88e1a1..7093ad23fdb3878d3a8c50a48e6f0b4ca11bf8ce 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bca782b77cf1da7a504c46e13497440e26d06c0c..fc29d538cd18cd9bdee69885f0d2552d479af129 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd7dec4d770d2c5a43df4753832835ce284672de..babe567ef20333d465dfa99043641a6b5709b307 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6899749bb29ad0bfe399beff5402fd7b905cf2f..11b2cc6d5538ef5b19a6fc9ddc7d7de1f6b189a3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8913112c387bf219adb510b6050e3f06ee88ff89..84b3fe9bb1e70417f47b54ac9a0fd2076025b499 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a4fae701c4e60f75390247f9deed9a372e85af5..e4947451bd27b698e15b6ed2cb0532d4f7f3e1af 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2022 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae85065faedbe1cbabb6b94a42d8260898be4066..79f07d2d9c6f201989ac5671d4d181f37cb47779 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc10b70516a5f6bcf2f3557df633f576bd47781c..66de222ac9772d70c7cedfd5b747c56f0fc1f790 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 566ea28ef25c6ed039434a67328b43444e5a88d8..af3020bef585f0db2b9fb964a8bf74f6289974aa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 218c92987fad7621a861e074e438f8a9ae4a1238..111135b87040fa198175f868a753be017d2ff276 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60d4ab872acf12a664bdbbd5b838e20ff5673659..18fe76d3488def43a5cb590e45161de580dd974f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f624fa4436fcea566dca04cf35086ab29cd4d54..4510a6b407c8fb7f26495cffc72c8b9b6f91560f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 67964ecf1b38de1af3f10bab2408b714d8195e2d..bbeb3115aff6d7321aa6fd26ae636c3c7c07a3a0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e47367e7ece2079fdca92dd3719b52c70c078707..c2ba3f09252d394562c5549a6a7ce7d4b57b5880 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2024 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9214d1d54ee7756843392e669cc8d7451125b2ec..b4eeee6fa54f67eff5240874257f55c1e4ab0da6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2023 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d1db6f7362c1958137fb2c401e9ea443468914e..1526670dea167de82abb4dd42c430fe553962a5c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4a984c2724cd261710cad7667f787eb57d65136..2eb7f0ff6d394782026b565eeed6b02c9c98be1c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a1d5daae87899d6c75d3bcd077ca7621345b4794..f8a4247aa50d142e86ecf6b1d077776919d51afa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 460491eadfc1a6224e07e8935e3c16d22985022a..5cb4b2555963cdf20b5a2d105256acec2e6d1b8c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2024 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4e02a8708fc9a120b61731422ff17ff4413eafe..daabfde3fffaa308510f90ae2546e2b6897d394c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2eef65964dafc927c0a06d8ed27ce2c8e5282c75..04045f681922d456d8f28b36ca3cb1b913506ee1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab7e5fc73f13c92e262c749d76d7b5fc18ae77f1..033f565c2671bea44b630172513a22231f91c000 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b26d7622806c723643b64c91c3386f91ddf7ee7..30fbffaeb4ba160cdce377235fb279274d7d13a6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3721ba434481c55fcc0d9b8a83354c9c33c63e8a..2d881997d223d6106bed09ac63a642dc00e61bb0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e6d8c66ecea3e50624bb072c1476e5b0db30e8a..ed458dce07ea5d1e495dedc2d6502dc52047edd7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6b0c13557c2eeebc6330924e72adfb2e1851140..6089b91889a97e8abdb30658537e0c0cadf92bfa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2022 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 501b831dcf9c7e50da5985db5b4011c7ddc7e8b7..c9756ac693225742495b38cdf38fa39e98d8b6a1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2022 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a68f10e907d3588471acf23f71cc442740436622..600472f3aadd40c53c0e8df37216a4b2e56b9cb6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55d14583a47cf8889a343653782a9eaa654bfd13..ca40370fb4f1cde14f56166a0b5982bfd1f0a944 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5478d33828622ea6437af0d3eeb3b247ccacf347..10f20c6d2f8edb599731b7138cc8b45b619c400d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f0316d21938f28a9c3f8e938161569be6d90048..e4d49c6b33a7a561723caa08898c04d43a3f4742 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2024 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9f11940dfe213b0c4a24513e7c99775f975a9b3..e0a01e92678443e63b8478f45bdb268200364081 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2024 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4b60c244b41341bf9e46381fafc0f4ee457028c..73897f596c850bce00090b2cf1def3b878071dea 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4c3ae1c566a72a9eeb6ecbc0e0bbc7d72b5514d..3ba0a8fa95f8662658eb532f9a84edd046e32e61 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2024 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e15784211abc6639dd55b85bc9615f898232fc21..a088ad75e5380bfa19071145678b75729f7770f9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17b39d5e2c9a56b34e34a9f5e18fc9bdfc21e361..cf602824e2a9b1b3268bc7078b3777bad8f36aec 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 65ebf8e87ad6ab2acaef5a9173a76868b985defe..e5bf17126ae5cdf1de9084286303fee6d7e917e9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 09d3869df46dc23ec5c42d7e0401b6adef143a8d..18093a9d223d903025c6da746d3278ffaa5138e8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0217b1828a3ef97e83d5080d00bf05cccbdc5eb1..00240cc6a297a12d1e0e526680cc53f3fe77877e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96f04aa81ebee20df8925060fa7e4354f3c973f0..16e74943b9896808b8a9428e1b2e2d0cde34ed3c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23b4259849bbeb5ceb51bd9cc0d5d3836a160732..beab1a7a79708382a80270d934610965ee658467 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23774cb192c7d9e4bc8091997d68d7ed12d45517..5a49aebfbcc5f3a1e660b2e06414e37663c04a7d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a95c5b237f8a219df1e7fb72cee35c81b750331a..b7985d159d75ff57c4ab40b185c79c63ea05d905 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2024 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7420b880b61803218f5b4f510811110bbe724dd7..e599ab5199cc3d34c5cd9932baf1c72ec2a0b7f3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7dc9ce3c5def744d93b5980d660143efdcce0545..1019ca7a6e115eb0f0720823111997c6f9d0de86 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f8ac79616e4253ceb46bee547ec99ddcd49bdb03..c37186bf7657de4be1c851cd0823e25f0dad6cd3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f94f95fdf67d1000a13d44651a60a289ffe3846..3f224a545a0c442e68a02494ce49e095320f9fa6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a74cff254869413c880ff7afde2f310d67fd772c..daef7c4f97f403ad58f61c98fb4b7195a5d954a1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f20639d78ce46602fce0fc2e0cd8aa8755f75b4..81c59a4a4f8cab0bfcc45e0afa0dbf6bd568ab96 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 263a4d23f1175e56bc8bb6c5f568b6624bbd4ca3..9e0adc7beaf2e36462857fb0b3da85410be852eb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32aa33bfb505fda9c09012933b6a414e0f15c717..a1ef4cf191460726ff1a715c7ff0ea1fee6e7fcc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e0acecfdbca89ff78393b88b6fd521ab90a6e4a..58a4a2aa34c3354d46d52927aa3e17e0babdccf5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e345654075d5b9359a295ff1a469294bbaf4179..dab4c2ef3df93b89c54d201dc1302ddc6e4e5f5e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a75a0493cfce17178577501f9d968fa0e7e5ef4..330c801fb06bb04af8e8d288b214f48cf070c648 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index afed1df578dcd9281db7881c0b711cd59f742319..57f61bab2d5a8edaea651e0dbdc793203e495c41 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 924d81101d9a6641058f15948e20e8864d48e9f5..e586855b69ba12069ceb909444e36aced36c92fa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d73bf6388bdca91823aae4191bb37a3087fd1294..69893df760edf51fc2afd4031c98df28201d191b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad166a60a244bd0271c89003d5cdfb63d26e96d4..31337ed430fc67821bd5268537237ca6d7c1a90d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c34ba5cb08f99df5cabf70077f0a320d60dbd3a..9a5601331e3c6904babfd7d972b8d3eea9d4805f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9194063ec9c2b3c4a9751d2ac2ec1866cd41d1d5..ecfe9052eceab5104289bbaeb142c6ed76e27430 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ba1ed582726e0b02352fc18924730e25fec8e30..af861dd391d0b85ac04844f2ef11eb7b50b1dd61 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 276f9d8c365de849ee2566cd0a2ebe581a337ffd..c80bbd213c40f329d3733564183ab552eefc34a8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 064c965b57e5094649a09f28c99d1aab0287f1db..70c3ec0c76b8115ae7924d792fe7f8323ab5a4c1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 581ee642f7b6d68b6bc537ceeaf1473d63d31f4c..96a32ac2d0c9ab9f8530215c807df0962b9e2bf0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0755dc109d67e8e3e40f762e3e22495c845c9787..e2549d4ed6ca4038593fde2d7008405fa21eb864 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 829cd8bd1f4ed76ace3922a549d3a1b2aabbce51..1f6015439c78acc1e4446df0f919ad1c2e31287e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c6d6444e8d16a122ea97bf368fa8b0a86e53199..5727a611f53aeeeceb975a672726bbbac5421102 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1514d30eb83ccba638b480459b24d4f200515682..e3acf94b31b6efa73b82b81244748470f7f9b303 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04883c776f79d414ba74f8c5202e7390315983fd..07a1faed34a3b505dd401e505bc51a816e728895 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2023 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c7848240a59bae9164882097555e2486219bfbd..cc2d794b509352d5a8baeedfb9f5133caf273766 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2024 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d8ffa6f33e602a3c6bbf8e269b71d84e01a577bc..a068c709f8b86e3a85df2433ce818d26a0e0f2ef 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2024 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b34e1238260c738c3708e1109704d608aef24303..4d4e4c20562e14c9fe64645153c7e8e1dfeef53b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96979e2e6c24f9c083174c7a2abcbfa07b048ab6..a19e01ae04f20a1e7bb674097818a9849460cacb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea8113ca4a8c8814b62e8cb8fb0ecbb127eb25f1..3a2a9d1801ee233052d05f2349acf69ec3d08487 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d1b2d014b214802ad94e163bb433814bcf62c72..ba0d5950de40027f890faba92862665f10a4ec68 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 49c9704b971332e83f4f8163eb96133fa8eab249..813429338fa112a5bd3de7188f225698d10f9931 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 78784be8fe7d0df3dd540a476502a2734135c8db..8cd8bdac9c59257dd824e37f5256fefe73558370 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 058adf545afcba4afff678f54adb78fde1b0881c..5060a9ebc8e1a7e810b4edfa976c5251584460b9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1bbf1e563eaaca4692b275e142c232f945f6c604..4b132d6ae24335bda5c7fc0094ecc16bb5711d99 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ce32dd2c105caba723c6af26b69debaf09a2195..7d75161691259226857faaca16ec93f78bd75587 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d2e6da7cf59c4e91d31811d5235b7495175535a1..2a0730d9f402963dab6eaff8fe47d1d6448131dd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index deee85cf3883742eb9b16acf381f309252bd3ac7..b054f599bfbe54d06f31fab221d66b8ac3467611 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ab905c41f518500784bb014db46bf6608453312..a08c0c2f2255fc1501a77ef11a521a6896bc2be6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 788f2c7e25c91dde9230d05a8231d83b5a4f5a79..22d1316849c3e45b9a512efcd6a57accad81850b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0157e9a4f3e549b0a62143832aca43d437db8b88..30c813db11e8303a1b06fe201cece9a27b5bcbd7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71b522d84fd4edeb6656e62c4673778f56299f40..69fb3bd655f1d6427127f3247e674a4bdfaffd46 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2024 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48c2c92ba9813ac4e19becea69801053d1ecd151..9ab9b865df77c07247b8f35328ea7f32902f1cd4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 90226ee424adbd5cfa2e256e94d2ce0eafc368b8..b15cc8ea1cad7732fd6ffc4945e2ca34d9d7d816 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2024 by the deal.II authors
+// Copyright (C) 2007 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5d0243695b50fada0e9dc1c5d6c99139ccaedabd..36a52f72125485f49d1a575144dd5f1303eafff3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f7ac78b0a1162fc06bfbd3e1fcee90253363feda..daf7e19f9b476b85aed7394286dc41810beb069f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9109769da1c949eac6db5c652352560053b3862c..2b720349cd3063c1b355f2641024019e7bf07c91 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c4b2dcc3450ad796841097d3add8dfacb77332e..c51bb59cb97a7a8ae5afd2f4b3bac8d77571d327 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b9cab00ce0acc4f9a5280af6900e8b624addf52..b3b07ebc7fc5f7d5933d0ce5c123b64c054fea79 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4817976afe99826f984cb9cc47371a37bcfabcee..290700a5974641f4f23f984ddd38d0cf868e8d06 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6214c6585cbf14f42b8a5b8a005e3b3f594e3c37..d472909ed14ee62f8adc70fc9a28bacc64e9ebb2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 41e42d3835e776864ae437e50534f4407d62d9ae..277a1840f1a7e766501ff5598527f397a83e77f1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 935371d30b945b296c11c18725f36988eebede98..6059d2d82531d6d8211e4e78fa22f8993afd6f10 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 398cc41acec29ca6606db0d9f07e0f318f94e507..50a19fbabffa7c971dd28eaeadd3b3e88818c2f6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0789d53e6cb67994850cc885db2bb31bb78aba54..e015a5a0ccab111b5bfb8595105caf21c35516b2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6435a938961789ea990fa2a7eee53d1c7ac4a662..1f9d3f49de52758f0e863861008fcf85b5234d7a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbc313ffade2fa9a018f15e04eae8d41e3695bb5..3f983632862b48967f3b3b69a5590a40a16e749c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dcc3babe71bc804098a2229df6f6ed7a633955fe..7dd23bf901627dfbe0a8f41537e13ee2c02250f9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 44fd8093b4f2fa146c2555c174761eb39acf2dec..024645b0d6701138de8c538f8e1997c00bd44b26 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1411b956eb1a6e8d545e74db41e4afa549cbfc7d..b84bd7fe1ea69fe39b9a4ec881c3a1866e61242a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d7ab4e6d04c7c0fcbaf929f929087ace5e73af4..323831ee0b0b81059094d05a660139c502c3eb56 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 081b5f066c45654839ad394ed5f961346070c335..3a508ad9741f3040ec3986211dc6dc29ad03ba7d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be4e8127d7e56e33d131257aaf831f151e6b592d..2caf3aa0d7a086735deb544ee09436e5513169fb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a7b6fa85ad08853ef0a3a80e81231e6c1a2cd15c..d0e4632a42b111ca162346df41446222b4639ae2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d64294b15dfe573f17163bde80abb4d4be8bdf2..6c2242afe87961341fd21b3bfea65e463f445360 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9522099b30ed1e26cb9afc48e7ecb3d4c3369e6c..e5d1d022e7c45486cf7e309dda1d11d5bc058334 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28c27d61d58688a1d82db384600d042fd303b910..4c92c94120fc47dfdedb0e0d60611ada9d472c91 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 613c9a2e523ca88636de9fc7d4b66e8e843c87e3..de9a78abb5a48743f0669657ad9c69941845eb0a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3168346cada12639fbe782af4e9b09af95494900..55202af0381be3c60e4bce6dc7d0f1678a2f66df 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d92dc4faccca682f67a05b0ab4ebacc64fe8e2e9..6eb9f9da12a88384ef2573bb58c9dc2ce0e6d2ed 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf71c8d4b948627c9dc76de3b7452ec4aca582ed..1e55053dcc7487ddf062564fe64b14d6aeb2e068 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77d7845662af59cb4172dc34ef79521abb20c08a..99936c5336019074a1c06828be25ae4a4f88c120 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8619ee71d7a2243dc9e3896d937828cb4363133b..77ea2bb7a6915d0bc9f5f592dfb7ee15f3029199 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37c7754eb97a97c116466ad78c3d996752ede7aa..efdd9cbae654165851c979a1eb83c0b067ccd1b3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4df36ef02501816ab15524f75ad494280815549c..bb306c94ce05d27e487901a2665f4b701336ed12 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b70ecf6d0e34e5b13564ef9c7d085b44f2d70405..ec459a6da3427e34edf902f8ce470d70af3e14cb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4eae634c9a41be61402c0aa5cadabc1aa5fa257..ac182f76627255fe98518c5d2a3bc9b26c5e494f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ab09c7f7d71b018206babd19514834eb742d205..3900e4274ff09ee6f7406f3e975b068295de80f5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 24c74509fb616106f68906e18295f90132e78850..3e83533a9330f88f265e80f7741cf5f264673103 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25db2e32bc0467bf4d361851f9fecf63841b0c5b..25bb889585dabcc65a9bfdea8ba5202ce04b5f10 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 700eb387061260c33a79517d9bc1053b2f976877..a6d290382e856b5ddb86f938ba0e4cd54aab5e26 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2020 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc7a81ef32d72a9410df96f2f1a115d933581b82..6f173e97b204c314f87a16ba96570a08c2b42902 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57cdfd22fb438be3e28c5ddac9b8b5eb15f24b2b..72ed5512a175c9f7f5902391eb0c4112dd2f8a10 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 65c5ba17b1b358dc1d6b4ae38ea5c7eecc22a6d4..e3da89130f4e8b86f5d540399dd9131ee8e28402 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d31851d611407976fc6da911bcf9bcb772f8d374..0b2d11be0a716523498925822111ec62d79deab5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2024 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 65b1d425c353c4c15b425e50788754ecccd3280b..85253a36e8720e64bd95fad51632e111c00720b8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6b89b66ae0fd408bd1e481921e346da13f058c3..5c1c5c8d5cb5f668bee0c3bdfb582194811aa79a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37054d493620a02d6c7b079aa6191472ae3bec7c..f178abdfc34c12a15ab119f0d5a994e335c44330 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39e3175c2f2e3313d4d66307d72bfb4a091f4206..33e324ae808cc4f0c04e238a1dd5fe24913b09e3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f9de6640cd5d6d8a3d59a1e00dce800c97fe1b4..b1ca442f7aee09bd795bdd20876aceb682ea6f67 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5db3406a2fcceb42267e26e4294be5618d88fd15..f29690a8cdcc59d4808fc44b49e0d5902b7918ce 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96e07ac931f8f2fd4b5016bdeab0accad05e64ca..fbc9c51736bed64063ad5da1ea726031155813e0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b038bc510338ce94655de77bc661cb3f5559fce..ffb0a54f11af0bde92e86f758da96e58e640250e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2023 by the deal.II authors
+// Copyright (C) 2001 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9278944c61768636eeff7c123501f7daa12248b5..e8ba024d206ad8bbd0cea4c41bd6e9a60d05a0cc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e55bf3a3ed4a288c1bc1f28608394617d795d9d..6f3302449bd2178b2a8805a0c78677aaae4ce5f6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2023 by the deal.II authors
+// Copyright (C) 2001 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbc8a54902087c2ed89dda0239a8611576d02412..8fd3fee9e3c061f644007e928aa88c90c080349e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2023 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1fcb7ead2296b0951f000570875d51069d47fb5e..8a42e9ea9bb765936e89b86ecafcf1fceda3889b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd7a8295c09abd11300b626822bcee2dd87bef82..6362a6589d6788e6c4138c5e4538e2a4c0d585da 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b47e3a6fad56ddef32452591fc5cb42f18fe643..17f522547fc9e530028a23835377640ee399d18e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4aec7ca9051ffa6efb67dbb38222dd4b53d75f25..89d50579334cc03a73526e2e214f5cbff4ee8c75 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 08039f56057e566d23adcdc97cf9609ae3a13b9c..d51153e23dde44b801f978a4ff0eda0353afcfa5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed99ed89de0c2d3a4eefff2740e26da5b3198329..cf30d7fc44724b74d6bf7aab67163a781a5c0e43 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84c68276cb3d1d6b6df6af7eec607ab68ce32f68..b9a206579df3c65fb20a89b82cf7b6dc035db293 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2022 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f260c83fe5c61076437e29c16b8be5796954ce80..2bfb826226444ea65194714c5943fa93f6436e73 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7022f31c1c52f3ccc2276c146b1ab8ed3bc6c35..fa8fcb65b879083e77db2334fa66cf186304f80b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1458db4770a61cf06b402adfd160cd5e4ac52e48..c894d5c0cf5018e66fbc12277c8a232e0ee922ae 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93931ec7925c66f0305cbd2c7ee6197f6c51755d..2b9643a9b003a68dc16064e0d8ca1dc2003dec6c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 514b7ec310aa63a1fac6fa37b4ac7bfc5dde6f22..31c342e6e07022ea7c1cac4c4ccdbcb407a3eede 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2021 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8fcd1f17b3cf8319e467c7838b480781ab6fd3a5..0b008f0e82d93fcc6a501b12cd720eb0d8908f56 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 503cdbc53483f1688d65643a1d857d052c40e6fb..c6fb18293c8c0f04aa7acaed9351147afa843223 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf36b7f2bcd3946171f9932b1de6fd3d6bf7f1ae..3e973d9e2733038570ab131dd08deacc919ddfd7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a0c86f127cc5dcab2a2cc0d76094fed43f4c89f..21556d298c8e8e5817db96124d8f428819d280a7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be7104a570251fffc7f2f146d4ada3fcfccd5c90..bde0db05257ba29606ad239d13f5c3101c10e355 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d077755b9c07ec63f0b3a7d72e03ffcb80a0804c..f72b49d18238b0f210c93d9a82d69cf778199eef 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2023 by the deal.II authors
+// Copyright (C) 2007 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ef06582c813731d5738fd3f5cf6bb6c6e728df7..65bb8aad3a2fc287af17624cda272382c226276d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2022 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b44970b40ddd81a0875529a1251e53602542644b..7738becbff11edff27b4671fe39670e42c8118ac 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9955d975a8e8e9f0ad626f4f7ddbc480a8ad6451..723c2d62c98368b7ccbf9e4c182161424cf6fbf4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7c03f719acfaccbed37319e99acb0605dff123fc..ed8b79ea043231619a8ed2db942bd72d72ada52f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2023 by the deal.II authors
+// Copyright (C) 2007 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df5e3c97efeb0134b8d8dbdb9ad54a80554e3a33..6d18f4a5c264d53172cbf2cb4ad461ecc55fbc64 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ba2d7dfcc2965f6219fe5ec13ec042b1dc2415c..5c269696dd55b5d38e07e3fd424c204ceabcca5f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6783cdcd01289fc9bb4b44a5448575a41da7508..dfc03012c7821be8bfeb0339b652b15b4760ed16 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b5bd76bf8157deac3c34660cedee54c195dbfeb..2c375dd0b6219fc2d662b2857c0d09030ff676e1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 61111d0854185af4efe6a15a2c45f8a404c3536a..c3744459270007e54a448448f455a5ad31d6db54 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17344ee220ad3c5905bf2cd78abf4293389d1c74..726dbe9b4a5c17fb42a37ea82e4b73304b12a5e0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab5159cdd441c7b8fe5299d271b96a5881614179..31902e782619436d961faf6bdda9fdf4454b8b6f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da356f8517a1379bd0bc573112b5fb60c74fbb14..dd90a5c74ae3657a6f516194dd90b8736695b7ce 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f51c6a14505a23c06d0b5110b6d0b4797b819b6..0047963dd38013608b253b1c86cf49e56e5363c7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad4249d54ac9cbeb2966a0893519750ec453f7e5..91c6a883ffa0c21cf0ab19648d05baa52f04ea63 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60ed8430f2e99dff5e4db466eec3b12be4056386..e44b529ba7daaf6937baa7b074175f7609a85799 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 038eace54d3aa11e50eb9641b4eca239c479dc68..585b4f53ba04e3405e656c107e514eae56ac6b9a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6065dd9190f97f06a0910e78a558532b11d07e59..5303eef43846a79d1b8ffffc33926b8a977a1326 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb3ef96a645ae5c3f7a36863b534e7389f3eafb6..1b7f1be89cdde39474b4102e01abb55a263b8e2a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c538b59c43594dca67b7f1a6443904c57cb319c1..4df03315a5df426b8e172568ca83ed1e96b40a62 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52c92f3988d857c980fa82a46894ab9d8d61fcf9..9a157f31336b0a18e19975ca98660c0e265f4a5e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfa32048fce3389bcf166f7ab889db73a66705be..43ed47bb718f2d8925594c9494376be869984fb6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f388e12ee315c72dea1c05058c6f954205f7b61..b5feaa2186849b2ad32af6ab2b3789a3f3e32ffc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88dda919a502ac20570853a66c4a8473ad877c91..b465aedb5194278d7645510780f717c3b8b94d06 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a3c94eaa2741c18cee4c42bcba6332aef7ca7c62..40938a7a8bb7885081f0e38f4bed87e34ed4f452 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfd8e5863803042bc10de5596adcc5662fab3daf..c0d75bed16ea99da804464e2c674183bb2bd8513 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fbc2d09daa4e7df18b71cab54bd6d6f421163615..d2f8763eed9f7a29ccd9967f55178d156892167e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9659002ab1b8f1805c18ee29411efaa938f19a4a..1bfb42a0b2c4ec4e0d468cf0f1f6ce15f4c30325 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e228da6350cde24bf93a31fe9bab5c457c329c73..2945c70eb9ae127de81be77e76467c80b175c382 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 667aff2ec8e2eaf0030991d12a2f8eb05091e620..5dd32de703966a142911b10e5044291691144ebd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2020 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b420bee15919410f29e62573f20071057eb712e..0fe7943f2a43f87c3a3f820958237ddb74a6942b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1a0779d10abc002719ef2a46dcd2da0aa492e56..5206d028c6a7a030a30a082fc06ba9175707f0ed 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d33d6ccff95fbbf3ddafa56bfebe9b8f529c8952..e8edc8015ffaa747d7196e0ff78a82697bef9446 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3fbd2dbe35ec1e6a8763d8d4e43a2039d38f9cac..7dc25cd91627dcc4fb85ea6e38e6f14cbeccd326 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2c55ad0778c2c6b4bd5e87da4aebcc36f5727ce..2e4df7af40893551360191d4ac45752345d2eb21 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2022 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a19e47f391e7b44c7d796d95f9993cbec0147ad..01c4f23e1a50b559a27a2aa1b670f0d747fec6f0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87d5980e78f5a7c6119be84aac36fefd8c7f4a6a..128e47d110ff43e255c4f1d422a47aec5de2cc74 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 49097ce61a373db4c3b47e8c494ba4654e12939e..ca75c238eef76e48cf1c59a8effd3a1479a835ec 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70ba2e90e545dbcfa6ff56698cbce9b57186da03..eb7293a6ab9d11e337eb7e091df04cd98a802747 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2021 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34968e21b59607c72faa6a00da10bb4accdf4a55..944b5fc8bf5cea330b1e9fd369fcdc0232aca91f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2da8165b1ec600e3df921eb0213b8c045eca699d..4127f91d143231c876c299b261de4bcfa87017a8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b1af26b13592920aca048b8816e34b6796ba1db7..56f722a5a1d853b1eda9ee4d422f61127e4b3389 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c05da6dc8bfe2c7ec9a963cbecc5592a3915fc03..abe3b45bd6e3b886dd6cb940cde46b765db66388 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 20e1134941440fabc5bf5fb5d391989c3494f706..a228d8f121fd9cbb21f208e32f0285e8179420f7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c7dd39ca10bbbfdf662207fb3b9572f432dc6f49..54192954a2c01853608d6bc4812b8fe81dfc7a04 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80704e9d8d628a65d54e7393c069a4dfddea80a6..d0b73d49f990796c2bebc45cda15d52ec3537a55 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2022 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0791c17d4abde278b2ea56698c01c7eab7126ab..fb03b4152131e6aba129bb86e6c9e34805e52d68 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2bea34d67678db3966d082d9cc896060ce3a153..6aebc034eed3866efa91b073142b575b3c343b8f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca6b1ba99ae872a278c2d05cb8086f74aace6d65..90ab4689cc301e6a3cb99b34480d79505becee6c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 09147663575194bc01df28bf3f7d01673a7de6e3..b29b12c4b28b111068d1087ff9a15a1b28e25efb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f24515057826e95d74f3573593975fbd7598779..a98123b588b07f529a90320abe9ab1b070f0ea0a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 083ab98815e43d80ec5eec144dd91ea3c7d4ab05..d953e0d0fcfecdf671375e54e0efdaf8066b283a 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2024 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index a39b8acd087c1b1af733a96d04f64bdc7727f6c3..a8be47247dcf305080cae25d7f09ad460a6bd379 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2023 by the deal.II authors
+## Copyright (C) 2013 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 18bd961c385c38d0a20a6c77b6a453226527fca0..58ba33287154b34f4c054f7718d2bbc448b452fd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 492f357e65aab40d33ed88311a59a4a82323315c..b174a0c8e9392c0e9f03e9c96e3fffbc22f424bf 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2021 - 2023 by the deal.II authors
+## Copyright (C) 2021 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index b191ca27540b787187803b8bab8ce346e4ba33ba..34829fa1c91e79cd8c975612ce08f0ffaa70d47a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d8423fd8666ef222e7e3d42b7ffc5715f8123c91..045e978d3eb14d6c431d683beb862519004fc98e 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2024 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 60a5a58c9bf9edeca49702d7b763bcaae68fe621..46afc25ac839580e6753175cfbb91471d7fe7600 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d2c03be8b21a868bafcfcd36322e714ebbf3fe3..14ed0ac9c9d474fbe9db079a72c67e0046f0ede1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb89cb80eaf8de3f80f74117eb5c682229a0c109..5a95c314a52be172e4e849e44f4372275ac5c643 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b72e9f273c6b86072fc0a369578cb2c79dfb1a7..a56de00068e68d541b5108b8fab22a6ad6d8ed48 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8eb451cfa6bb0bac5772c505fb72d509b15386e8..f0a0fdaee3353d114821483d37245d4f7079fe09 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d29d95ec3fcc603cf1876b0cc67d38dd972280a8..95c3dcb27c0b372f6f50b13a2959dd261bfddda8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2847d8f4bcaacf79b4efcc3ab6c3fabfdb47bad0..34a4c8e81257bd1061a0f22c77b6bb193e008153 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68e466d4c9ea3b045b500ff66478beaa82a344f1..b9910d27c75cc81e25f4aac269fe4aef2105decc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d73940ae4aa53c429bb1f9d041e60c60b19a4205..90f48a7308d366cb9f27d67702dfb89ef75674cd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 442476435ffc466115fc55a12f8cea6b3bbd5003..fc099bb9e7953317e0791940f4395a2ec2f6e42f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2021 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b303f4b5b927d0d796ea8c9539ded5aa58b3cc4..9a186eebf2af9e7490d54cccf0d41de7baec35ee 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2021 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47c3e4f53e2fd1ccf61ed8a3853493bdad10b89d..7ebba5c72d291bbf3aadb3c178d2b86f8e8135f9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4dba5de0853caacae6ceee1b10b341fdd4e6b53a..079ef41f12519f9b82f2490bfea1fd1ce8272f01 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 41ead770800cb12ebb475947172b62bfc228d706..59a2d07ed39c9f99119df43f9f4897ddd771b960 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e396e417ca072c97578022dc6345c36fd4b90151..eaa421841ae3a459920a63f40fb8d3fc0f0e44fa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21189c87c811abf41ace18ed0303db6356181ffd..427a760cf06294468a2288800a35a3895473d61b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index edc66effb6b08cd6e4f3714637b14b20d6ab00f5..feef53ec9cb7a0fd9219360b9df03bdca0cc7921 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86bf7b24c107acae7ce673d4219a8e31c6f0c6e3..524426dcffa54d813760ae190f98183c98374884 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b825130c1e8beda019e82b154f8f1fca28fd0271..288d48514cfc6942e9832fd255367c04b868fb3e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b756a84d9a22cae3000ae5dccd9c3178e54e45f5..4a0d6c2c27c1fa2199d3e40090b327fb2534e6f1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94e1bb08aac77d406ede22c568911cb9de53ffd6..ebe95647de30fa9b7c45be1870e01df7276a254a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2024 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d52369441ae5637f07dcaa096c5c42667bc765d6..d9bde45743ea6422b23c63fecbd129ec6d99a3b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f61a9f62d8c781aa4de860628e9b3543acf559fe..08ea0e6184d4603e144156dc217a455c18abf36b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 686ea046e753d0cb3ab0ad2512354ec6066eb5dc..fa9ed987f497c01d3c05d3e2cf55dc0cc03fa76b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 338bcc0fd1f12b541ec39e5532a12210906cc5d5..c6c555b99bf873019b135d0dceea0c354dc4ac8c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f72ea05ccf6fe8aaa5b10ee59e133057d591ebbc..9238b2304d3547e11201f4298abcf71958ed0958 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04b615c150cc4ca123a4222b1498c3f33b14fdcd..d2198c8e1a84aefe5ac5b1f73f8ff9c783f36184 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70187d731fc2667f51f27784daed510b43a7f32c..8468710be775ddd6836c901d12704cdd1ce43e8c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ceae1f88c0aa8c45d4a290ddf4f4f48564b772e..d0f97294b77ea7e55fa23fc19b30c37ce09be5b6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa2bbd03c7c606898a180aaaec2628af9523bd5d..b46d7578f150b426778adacd7bd9284033a6adae 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8e391b324f3164664d3a3fb4b597c83871c3b02e..58eeb8b0f2a0c3b8e44b679a71fa15e24c9a9b78 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2023 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 013cca1cb4a252fd46fc6680c9e64afac3a49aef..9e3c8242844ac2e8fda1845f17fb656a95248042 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2024 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e356184a4e14366bc020add83540b039e93309ad..b050c2d5aabb0c5f098dbd6b02ad87bae3254d62 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ab8a3453913bd9b378ed7050e1255e459d9885e..6aa60d440c520480d20d8b1999cc613118d4ef05 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef483e1b5ba70eb9a578294575880f6acdbb4409..d47a72ad0bbbf65e5cd37e9880295e406f2aa5d2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 784d23059ecf0fa25c851b60a78411bda5bb2a3f..c45f3d3d38d7f423afb96f14882073c405ebd9a2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2024 by the deal.II authors
+// Copyright (C) 2007 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95d3bd335f519aed98eaf4c6e545d833f1365779..9398008eec6f67618acc79163010cc9a437a7cee 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a886ba551be9ec1a55f090a296d443609388fa84..32a1becb45079b8a479dea27755f421ccdbea542 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b421bc2364c4b4f152103d41ca709e1dc31142a..a0fc138ebe9cdd38b31bf8b9d25878fab43aac1a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 473ec6525e94e44987876b22bfb3c2cc373e5cea..d615aa0263df4f3c26eb9952701a5bb2e0316470 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb12a2f652f385d250cd7179c2555bc74cd319f3..bbb429f669b550157309cc3060b1f3d8eb9fd916 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d179dd8894ffd9a0c21e1db3521b9bf9d2e3beb..5c17052bee5607c0f3b36c4bbf302e7ca7a7c157 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9dec4f610d235f7f0f2ffbc977bc5e9812e25d0..385973d079a2477c59c4c0f8744c0e9a8e00646e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 871c08bf75f94171d3a48a4c6ca06c19af3c0be4..bb92abe573f663a447f8de7b0c9dc1f54a7cc396 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c1e4226935acf47ae91a035522c28376ac68b6e..fab6fc346806a7344b6f157c5edefa226c7d4937 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ca30dcfa5d4e3239f025eee6a5d283a8b8f07bf..7fec438d0e49d4956bbb04326e39c9e41434492c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 038c2ccea3f03f9e8e9c43e67c6332e6725364e0..35db7d4ce9499a30bf22f0c08aff09df43b94c64 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb9114fd802f09792d6c0d389130776351e73019..f1301a65097c1db120b960ffcf1c3268410499c0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11c17f0465d8d7419c6c4c4976114027c26a406b..4737180e662b193e1c10094c4e22c06c496ca087 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6dccc8e3e2804440d75d74915fea0b48233ac6e9..1a1ff981ec0754164c2c573937dd89a8cd7cc792 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21fc619567ec9be44ffc4524c7710b0ad540921b..abe40df510bf05a4f2afb1f13a2966c8a48ffb05 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2020 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d88e415f63715c2a3b0103249b60ef6f7820347..2795e024986afdce69c7805ad5a8989607f43562 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c402f3b55e8b26acafac193bc3450d6109fc6fbe..e65aed745f3e05cb8ee3b9a5c8389fd911714e60 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a905a7137c01fe72c2bfa96468bec71ce0c09bb3..de9335d055ee04beb32a63d80a418eb6e2efabc3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f45818563c2ee19256e350f4438e1098d1b754a..567bfed3da082f785a446e6afe6005ad93ecb1a2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c300c3eb7437e6266adc03cdb937af5ab98b086a..6afe696453299a7cea2c701bc8121cf0edf24847 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2015 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b533b9cdc48002028c9e17b3b995abc8295f09dd..2a9822cf0fe26b99416da3ce51195e656ed81de6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92140ea7459da26687b8103becac257dccb2ec8b..f9ed19bfe905085dd4535e6083bf62a3ed28ca4e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b1852c1aca946c6e9f17138646131c4c3f761e60..468300905a6f55bac0a24604368f916993ef6a6e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8608d9ff5d3ffd4024b5ff49a89336b0cf000279..3379883102d4d73df71f8d956a784a14715aabb6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 89af802f65f475551acd17bc9351e2125ba8e5f9..902e455945d212061849f3793cd220309a909287 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2021 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be7d505ff271ffed127242d64b4da8052a52b20c..a70f03b751b803ea9659758af4d08ea13ffc3b52 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b6056e488284a6043b138a50770040ae7ca5689..9477ff12d0080d62027dfbdbc75f6e7873f432eb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9526306fc0c58ea35a415b82c8f7198a0a53b9f4..341a6d96646f1bd0c8afbe8ad345e9f9e6eb87f7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af68ec1ad6367e48817e44e1785c485e15b9d071..3f5bc1bb3a96fdc0fedd80ea6848b1bd7a8ea605 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2022 - 2023 by the deal.II authors
+## Copyright (C) 2022 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 3b1420e0f3cddb0eab929e1640e0dcd572f755a6..8bb2694cea69fbe9e6d0a3e731921a393712b7a9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 973643028d58f790d2fd5c4f79019d2194ba15c0..35ea9314eaf611293ac73faddad167f711d46930 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae38b3442c8a7182ab3ff694ad763841d58d33a1..cdf3d2ca639223e84cc6bca4d8e7c9f767ed1cf0 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2017 - 2022 by the deal.II authors
+## Copyright (C) 2017 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 4047580c1f33e6836e5feefb903990fbf2cd106f..24a7f33196c289ad1bf771e0880f6451a868c750 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2017 - 2023 by the deal.II authors
+## Copyright (C) 2017 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 2cbc9df3a86fd675dd1e690a2bd2bba06319acf3..d57d2775987c26fc368f7d2ae8d8f0390db85c4f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f28edf876e1ebdb5a8c59ca76ef36df1b59ce8c4..c7cfad25c35c178bd1c03dd32b59e8caabfc4353 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4512359c0a4074b34c3a5c598cc47a96139d066..e3cb5f3093c3577840c06ade57092476b0f91ffb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9aaff9098a0164fb3b2fec26e719b363d40568d8..12831393da7b19ff2a8627b37fd0e330d089f5d2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb3b795787483617774cfe863ac157213edb5727..39ccb39291fc6b02b89e00432cda8e9fd3f56c0b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0c3a784bcf173d6203be45929ed23c00d36a9e14..84814050cf1f0ed5e502462cef9b0bfede34ed97 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6093495bfcef2968b70e3aa9edd23d1bf5f8fe2c..f3e3be5f985d171cac7fdb3949b8b9da186792c7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 659c5dba578c85e340f09deb3d1a6e738a701b84..871ba68340d2349cc06a2bb1e0eca58ce00ba7ef 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9efd4352e297069904b7362cd9d9458ea19b2c6..caf92bb34c619e9573432571166ad236a7df7df4 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2017 - 2023 by the deal.II authors
+## Copyright (C) 2017 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 0b1bec5f606767df5db0176ee1484ca101689302..d3777a3429ea484d6a12f816a2972c5cdcbf6157 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b037b9935d82e972d63e0ab4721e06f0bb2da4b7..9c1db6c3245225114361e3f2a63de5d7aae6faa6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f94de62852bae1ed971090f83dd3b0609a3114e..6433e48f0b8b8ab35d03ca32a74aaf94c5e43147 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 51a8363536dd5b7ddc1f587326545b72bb40b861..97818bca204209573ecaacdefcece9e65671e925 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc103e16a2a668a424534de449e2759934f5eb73..2def6be24463eabd238bae46e05237a339bb673a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d447b75d45dc6325e733d28c0552ca3a09fac4a..d460055d06fc81c19aac0641a5f71b8afbc70c82 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 91a80d415b75c2fd31a035f71bc50cfbeb6eeda6..2c886d14adff88d56f575c16dceff9e1e2e24dc4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48b900bcf1a97dea0068ef2aa5ef797d163ceeed..944aa0ff595e09c22ebde55a5c1a9c2791b279e5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 41e2385f04bfa94b3350d73a177c8f86d49bba90..3acd7b2248e677a47c85e0f18bd1f7e1a67d1c1c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce8392a457b2b8571fb7d6a406aa5c4b1e777f5a..f850ff4008edc84f6e52c3c7beae927f7a87c57d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7008f1e6a979000ee3e247c02f081c83750c368e..161e3d6b722f43757c4265ad49d67e0d5377f024 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2024 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60230642604b13cbc30cf25c212ac20e71e64254..127e72cc77d6d51800a593b49701de625fd47f91 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2340c610568b3873964d3b1b210c27e189d9ba27..a442e9fe1c6fd735cdb799d759b696c5dab3dfd0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 469316a42a308d5cd7c25ac6a3f000fe1d053dd4..1793ed40cc22c593a2a54b9425ac7e849cd4ad92 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 187846291da860301ff0b728bda2ad84f42a9af1..2a16dbc5881979d9f0ed7bab92761479a832e0df 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2024 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a4eeda0b3074b745c69f4f950ae5043e427646e2..339ab03db107413e0758bda65c7721ab1c148376 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e41b03da7df07644ef26b5bb56b1fbfc67a44e95..8b7f79b29445800078983671083798f21fad73c3 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index ce174fe33a3dd942b3b07da2ededad1f79789add..e0ddf3cbf9cf7fdaa99377d258196d9504535bb9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f041a812b1ee883872038791da91cdf3790a3d8..3884e5734359e7f3cfccb83dc5231502fcc33c5d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bae801743b50058ba6c6605c67f097f70f935b0..213eee2bf80e29bbacb2607aaa7761385173bf4d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5349db7098ec5eecb184c836bdbd8eca5e515dee..9664b91ed023361fc36e9000f8af94850ca08321 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10a5adcea377af6d85693ed9bfecaa682ffd7328..9d9c79a593dd918d3bf386d72ee7dce526ff9c39 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f82c01be3543827f820ca4783525467dd6414fff..9b0e8ec602da9c08822a24d0a0aba000ef6a29e6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2024 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10368097cb7aaa6791abd8ca7bee04fee9512733..3c7990aa72d8b57b6f47a8798b0b6bc34f23693b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2022 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0b0f3240e90b1f1e2f2611b9755d710ace1a117..9e7922237a12e9f2f304c268ad02699351b6be7c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d141aa34345daf442066a506917d37a344874f1..66ffc6bba3549c70f458115529d06ae7b4ae9c35 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2022 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31373fa640dbe8e6fb12ba51db90a6938758b5eb..572312a9a418c8057eec369b13c94ddecde90687 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 01c25461008583fda317c1c33a6082974412ac62..96d9f173ffefc1e5725faf16e2b8691423b351a2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e7927ecb187ccac8830ce9a1e999eb13fbba462..00000898ff22c6d53f6d96ae7f904d2ae6cef522 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c193ed71d30b362a41cf137ff6db793e11441e72..a12e61c53faee0bbcc247e1362d5621b5aac55bd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d68b04c260400336903e19381e464312bb3be72..f17e775672068ebdc0cebe204c3090261455ca1a 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 8569000edacd40473043c8b7e3c4cfaa54ea24e3..5cbceed1f1b08bc17ff29a57f586038914d5ed49 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21d637dc508cae328ef0dec80d5fe5c956ac8d6f..2ac159031863bdd587c96b84ad8df7bcd59ee346 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9f2ba873762c5127a5a7a45296c5cc8899d6eca..b5551f663b6fa9252f42c71664612b9d452ce95c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98bce41a77897d40b860ef22891cbb5a7445c2d6..e199d3b2b2bb81418121cd20d3bbd2191e10f034 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2024 by the deal.II authors
+// Copyright (C) 2003 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e89d8693d4ac60d8abe7a5f13a3b2b74bbd3b100..c9a2f4c48b55f7c6c3c5b031b68968969e56001a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2024 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03bf4154cf332c20e812a90d65a8dcce7a73f8cf..c51abe884636389a9ea054fc2d199b8809b882c5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07346da9070d4749bd5c560e7ad63c47fc7fe1b9..c676c89fa1b57973d032175b96e71b6594a48701 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2268a53c399bffe3013db8b64128a06612cb4c13..22a91364a76dfb250d45522f9a74702443d28582 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2024 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2304cdcb59843ce8b6e744554f58900902e2311..4dee07491b46f717bab2ba840d7ad3c50729fdaa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2024 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4964fd272e6faf442725cba46d5f646591dfd04..fe035b6b7689f0b3d66d0a7ef6807f5167d5e68c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2024 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbcc63543dd336cd4e85e29391aa1a46c548a167..438d26e02b812b8259768d4d38df7c99924adceb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd8e8345896277998a3305b619939b36199b7f0c..1e2618e1206afecf30e60f24b493731c9de8d8a4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce059b651becc06d04fe5820c527c571f445fedd..b4188b296472f368f1fbd0483f13c6b818d25df7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2024 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3d2856ce0db46f0dd4a72dc69a9c6edaf7c11f0..4b7dd622de86a99e162c6ef0ba1ad6e77801d30b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cb92903cacd5d62eff05d223cce8c2d0d49d3c4..3f8106bfdaf7e165a3e31e870bd1a38eed4f339e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b7ae1f7074ff37f543d7dac9e55350a585f44d12..58e77d26db702c46b9525141088b1ee47bdd8928 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86a381343f2b12c45fe72bdec4e8c9fa77e822d1..daa3a13ee2ce98aacf6fbc6fc6e76688c69125d0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2022 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6162aa925ae4de37dd3c03899d29b060923c98e2..3e3c0bf6699984167dc71549eb88acb7fb79cb34 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68ca48da512a3f513dfa3cbf4d1c5e0056999c6e..6ab8212e4214205d7d70b941ef04f70a790c8eb3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31f70ffb687bd5fe260801410d7f219c944b06ea..0a77b88140ff6458411e70369feea3bcd89d715b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce1efcb396f6fd82407a4759ec280cc9e1ea6829..ca6e051e8c69a173ef4e17f092abebc6a13824ca 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35cf173f0b98f34d63744d6e5a93308b76ebcaae..adc2790623fd3aa37cc025a4bbb36712abce3170 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 51700010673d51a360b645209be73bfb5e3862c2..f35f0d95b92d3e94c3e4f508f52a4ec0bea7e54f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 629e863ce4c789a56ff3538e460b91dcbec6ccce..cbb21e666fe35f7f4ff906fdc525be64dba797cd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93cef92bfc310944bae054b16a0e25440bc4c195..6f8ca37bbbbbaa429ffbe1ecb9f5fb6f3f353090 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fbe196f1cded2383be4f27f18b53065443a00373..f282fa793be3cf4155395dce413cc56ec8a730c8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2024 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef626fd23c875d301f59342135e4b98d33f19be2..2f1df9a719d6ca57cc37c89e2df5a9899f307bf0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74cd8df9013c7596ceee21e4bddc6364d94b9fcd..cb0239b77186a633e7c52feb6b880c0b4f3e3b94 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6911821c4bad568c0164946f24f938d5680c3eeb..40b09b64192f4e27e658937f2e469d65886ef8c7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2024 by the deal.II authors
+// Copyright (C) 2003 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28f3f4134214ed0ebb05845d10b7933ed6a34b2a..193047e686b84fbd991740c666156a31a5b83536 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2024 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7349e54d508af2fcd3d29be5787650d2ac9303dd..1a283007d730efa0db55547301478df239f978ac 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9b029ba153778cef06de5903aa5ac8e447d89e9..380f9f2ce1a959be1d6f68c72e4b07306fcd6d96 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 65190bba7a06abf9b85df7410bbe5bb76eaa4862..b84a01e70ba4a2ebd8a315da2497f2c958d50577 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4259fbde5507fee33ab575cb52e20292e6449fed..af3fad6c0531ab00c57a62ae8bee48c30e28cad1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa10c23f219f8b18e2d7e02a53c3a7abd4c209c5..fd229828badd8872378530d1df5ac2f1cda1fad6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f3c0406498b58e7764cdb9cf0b6809739639bc98..5a5cee30667d697406761ad57f1aa163ba45d8cd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d5e2b71ca6b96e16e5f50e193f4fc3305eb027a..e53c2ffcea81727995c42afea659e54aede66b12 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2023 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7c9e101c04ee93aeaed06e244c6e1386179917ee..0551940167029fa8f6ee52cf11582b9aa9986109 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2024 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 30396faee1fa489311d218d4a1581a70da03385d..f821987543d813caeb38eab6bf65046207b1b211 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2017 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 125369453f8b627e6d6a864a755be8de97c590cf..b3c0c4b5e354518262ab27058516a83f0893960c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2017 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab4247d22b313fe8a703fa8ce7372de1a3dd09f2..72e12689309a72b1ab40380a1c3de1a05717f257 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2024 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe69ddca62bbbed1514f27a7f783f7166947c258..85941175e35134efb001070605e0393a6eee508c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc56ffa821094ec7ffcea3f1e73e66ecba5cb03b..9371f1f743787c1a7aa13e407e6606177b196375 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db0b51b9082ebe1c4118b6643240f23444e5693d..73be31d6e4bf44dd6adffce6a662d2f2ffa42ddb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a73e5c3ccf222d9c0ddaa39b84e46895c0fe0c67..a0daf4498b885e336e2ed6e1b0bafb85eaf62873 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c05d9d39529b21bf1e66b34c4e9a557270881af9..9bc6889a6d275bfd7d1770c82abe9fd9fe850656 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 441567fd762d30bf0d7d4e1a125086c80c050890..e848d1a5c4c72a7a3bc4dbff94f162516bc76499 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d810586c5c5c710b900bb1405bc603fa1e328186..211d492316bfb07c423d96e7b38af8b9c12bb9b3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f4033fd099c9e001b61e73be6b55fd115e0ba42..036d4fb980f3dfc4887062f65be7741f6551fa4b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85108cb2d80a86156033fff254e623cdbe7ab178..a891995aed7309643ef4379467fed9efa9c3dc71 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f347aaf938057350e4e47ebe17fef24f0fd09703..6b5a58b1a68321ea4aa96bfb09570c037528f77d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2331ace722ca8d30683df465129b79a5d8814290..a007b2cf34f6d1fdeb72e6c4adb9766af737a46e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54b6672b6ebc86a02f3a7d8654f9731c2c8b7072..5a655e9093eb3ee1be5a527611d8a4f9c74804ac 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 78be82a0855e77fd9600723930b2efae27eb6695..7e68de6de1b1b81dc2ded8019705b48781d0626f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2fb76b296c17c383a4bd5eeeef26c5a0f21b2116..07cb7899012127e0a27dc7bdc6346378c46fc93f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2022 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a588b0c1605768c017a3c669c6bd82e3eaaa4e5..621abbdaa614d3f72f6983943324281027d0afcb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2023 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1682bb7696191a637986a0124c3178f7be3e8db3..20fbed2b5c5ff1ccf5ee0b1bfb0942efa785cbfc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11b56fa224d7e57a5b2af410c467ad841ae9800b..5262c0b596dd90d7ea625f1fcb7bc169ef86ab05 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2024 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0705af1d7f1bec3f861fd98ad0dd1b2f2566a541..e0d8906a6815e1c9e91e1227c44df272908be01a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a48cf27e271570ed60b369e485503d3ff27ed21e..8035e7706749dae9b0cde646d39b63da3d0048b1 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 84fba4d8e48c14b943812e2a39ae5a1fe4beffde..6be625f6f6370434a1d3c324b67bb28b7842e55f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b1c87ee62bd27a3cc6560f6007be18aa0f84bd2..e5494b81b51796fd2c2a5065a8cbac282fef6415 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 6f6e1bbc2ef9cd1d5131c486675dce87243f66f6..50d8adde8fac14b525796afa34ab1b0aac3b6ab5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88f3de4e40dd14259032e78598cf822056ef8f6a..54edb35c29fa75d24cee39d2804f35b10d8f5a13 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 200d16127bd8888ce939efb585640d369699fd01..2c026af08a1604030d238101e0f91e78d9117d96 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2024 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1440d666747b41b96840e87f1bb6a2ecad35eaf6..d6c6fe37d0e63d2e1bea5d6e45dbf04b4f68e89b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 361915d5f26086c6e130946c77389ea96483d5a1..4e33e177f3398628debc2400cef87ff03a0663c9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ac220f29599ea6d66b05ce44410280f29caeeb9a..443de774e73819605a914874c70d3e956501479b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b3098ba8ea3d846ce5e424f0a143a81888b6924..df58b3b24140fb3ec5f6bf78d192cbb2d65c3b89 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dea3335faeee3988fe0feb1473f2172e5f319b17..da8d6b3a9eb04171507a56b59f6322e595e7894d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0991c89f95750fe1b33d665ae6821a9e9dd54e88..e8fc632a076f8308b990952293ea1650cbf1b107 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 69c81bc97cdbacf56895ae585872847922f456ab..472055a0b10f010a4c5dc7fdce1e843307448ac9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f2bc55d7ce9f322455dcc5b892e496bcbdaa859..4f9a9158aa6039d1b9a1d2e9805798d304be2e44 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23e4c9a2e7ff436c6c856ef8279768f54b41957e..4bf094511dc3d7757f6c090bee8d549acb28c3dd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 194530d489fc6999274edc18153e3a3cae3bd21e..3ca51173083d772f1dfaf95f6d6352c0cbd6db39 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e8a0450524a8b5c2308f6b43b8300603b260fc8..a3a82bd50110897c08312940edcda8dfd32195f0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 90a52814d0c03958fc6fb5b94c08d95b6eb07264..27b97c280eaa775e6b724c98146b852c01f36921 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cce57024ee8aa11e6a7f1e082e2e907eacf46943..03723a349fdf64df43125d4c7060ab833bf4aaf1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a33488eb54f2ea168e3e28890bd9d3f086b2ebe..6ac6ebe721bc0baad7b8506eb393f07598575bca 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2024 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e33d2d693162d4e320bd32b099f15da620bfb32d..16ed11950a6bdbcabd05cfab8126d7a2a9bc48c8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2024 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 264355627e19637676faef9fc167dce5ba6e88ff..300d75bb18e71946e1c6a0267bf9cde65b619b82 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 62697913fe0f2ced4a40da7d5c3aea69bdab4419..ac36661a72d02fc477d5053cea752ea02aedc3eb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39113ff0c746ef03b91e0a311bd380643fee92c8..b5eaddc5f67d9c4d28ed8e5b44f4a418872f61d1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d258ff96e52bf9e115c6fb06d11a0ed5568897e..24c0027c05fed99086536eaad156a0e1f2c2e496 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2024 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9b8595188ad53dcf8ebfd0535074dee54610c15..66681e4c628a8959e5cef41f69ec8186a6589c0b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 485c256bddaedd0ce4d8591d4ff6faf60f6d7812..ca50b203c2d48cd37cb4d15ae5d4ee63d1b04675 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2020 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index de2654d75bfb2dbdc0362ebb3412314b3f2364e0..998c677872b89b5c2346e0166ffed3862b59d8d6 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index a7c58764610920299592926799609f2ee772e1ab..84cc574e2ea2fbddaaa8899fbcd27500bff1d5ef 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 080ce2bf2d6bea41ea216d3a69d82844dba48c3f..e6afa09c5389d7df2f7a604983a9c3322fafa4f6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce7e8f330ceb1343a54f1e460af8734f3ee2305a..ef72c160bfd5d4cd914985164634d822a131f1fa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2022 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a83d7b1dfef44d282e0549487d94864bdb94d57d..92260e7184a8198b56aaff66e445c59576fb514e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 51c2856d0501eba448708f6e5534fa670e8fc685..ea02e842f0ee1977714f63c75164bd46275793b8 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2023 by the deal.II authors
+## Copyright (C) 2013 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 68d9e1645f204b62495fbf8c2a0a7410967338fd..8a73dc3df12d88fb37c0962103a7dd19439adcb1 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2024 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 97d07f6aec6a652514cc425906bffd297f9847d6..f115d009bc3a7734b632977c1ece1c6e1ecdb414 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d5de48a6ffb5caa8dbefe7a69429ce8f73690703..73f808f9e4348eae770607a1949a8f707255332d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index de9fc4bc1a6e2a38422c2536a7656d0129a2ec84..bca6463cbc73f2a19929b3716cb2edf5fda7bc4f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2014 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d4bd3b3573dfd9fa40fee9c03155c2ff4d12af5..059c0da2750f4e50144942147e6d3bb2ad1e305b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2023 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d01f6057400a302b512332c3766a7fc6bb94ec0d..057397b30a11bb614cf584542512e31642d8602d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2020 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7af74229b1f877ba9588e1dbea1b8fb06b55b203..997e129d0c9fed6046b5b12986883c7dbbefdb8c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c164d7f6f60c1649de077424f9aa881d79fe820d..fb74d1e0f1aa89336c80f89b38f4777635673988 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2022 by the deal.II authors
+// Copyright (C) 2008 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cbdf2a2d1656d226e8e2df2cbbc33ea49ffb164b..e91de36bcd03047a34dcb1e95f9fb3472ff03b07 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2023 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 485709739c043ed3e78c6a0357f53c43843c4c17..de16a0e1cc644a96a467ad8179a92949272a817b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3017337d10d04ecd7b0eb8d3500f28119e9d8e9c..ba87cb51eaff2f69b7af1eb526c01b253510b011 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2023 by the deal.II authors
+// Copyright (C) 2007 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e997e9c33284e8aa57629da05b48454b851b240d..83ff617ece085a24d463c0fbc5d56fbb64efb088 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e97c2b5cf9525b7b3639fd29539b6b0b47da1f8..fef7281771162ccc054822e34511c737ff934116 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a0da272901973c315a285efd2b3ad5db7637a5c..696370c18d815b081b27af20027a2a7a936e474c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a140f63326f5ccdb6c3a8bd2dade7b2dd65c34c9..40eb7ed6308fe501b03e883a462b95f2a0791218 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4d55b24c18bca38f78adb333af259c1e517198f..4c45869815846860482fa0ad01a75a3fe00b6071 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3053f1d3d1bdd05e5a5f943af1617337f9f08a7a..f0defc71284a7670b88ca7334d0bc456c8879d2c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e3ebcf266b66772d0234c3ba5ea29386901d9e3c..17ebb7b1111d1592434f242324e66a27196a1757 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2024 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d2afcf8de300d0f424ee499ce3966733ff9803b..6ff8e3411d94167bce356cb7c06cfb800933c33d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfdef42de97992aa928f8d4ac2093dc55bcadd1b..201684e07d1a53c504feb94eb905fcc9eb970bb2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d581290758d41927514dfd66b185ee5d4fb86c6..93a0c3f81ad30fe074896524aefbf3f6e9a33168 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3144c1b32e2976a6dcc515198090e09e66e63351..dbf37abf9f1a8fd88fffd36985e88426860ae3c3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2024 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 895a4fdc392b060b48df174c3fcb387b18ca4e48..97c75685aba4cd4244cbfad6d10a7e2547b1eeaf 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2024 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1357b7cba44b9450221b92398da6a3c7e0b15df..d1fc3d9c4b8ba3ad5f9e5b6a94a9a706df4b25c6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf84b58d2339cbfbbcd1a2d9e9ad985b34008da7..fe711ea64addfaba806cc17d52b2f592ad7e0472 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 20388214d6a0007071ee039a554cdb00611361f4..dd2f66e0220f9ceee77297b03dae6030c61aac04 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2014 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a0b524e05109816ea4230dfbbdecda4f0872eac..e8ba8eefa4240adec699c45be227073fb4580b82 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 61859d10cd1a951717d458ce1e2c795af69e736c..f2cc45b13aaeb5c8b002d18d7213ed3c016a7464 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2016 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a75fc0ff8781332a1113538a1744d8ca614ca657..9d3ce6a06a3e348bf86d9fbba31e3723959ecc47 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0db9bc67dfad61f8997ed76de2198ce7b125ed9..741cccb9c35bf3794d05442a6cc2163e3881c259 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2024 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2cec022dc7c28a4e8e487b20df4b5c46035e73c..4754a0c38e955061d8ef6274ed353e262ed764f4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa1fc63f2d128974aaf2fa645befe70166ea8c77..aa634e05c83a638cd2ff310f99f5cc1a9ffe65f8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d82b47d74889bdf123ea741f569ab352f5d4498a..adfbda81a8e1be1d45f6e71eab32890a16775d5d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e8573b415b177fed1d7fc93c5bf93ea86833b54..62873c66bea8cedb5e30cf36ad3bb5b79d15ef7d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2019 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2d6a4acaab25981a14abed557636a22d069248a..310bd012980d9cc49bff2dfb348997abf63ef3ce 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 039e7e5da8c55a1d22b07c8392131737150b1f74..f55e2d63764f03d6400a7c1e99f8d42325fb8b4c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42fd9670209cf3376729ac8619aa74f1b8cb77c3..cbd84c51dd64e618d2c7531c9538103fe20d5c37 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d49ba83de85497f815b9d5628ba7ddf43e103e10..4db725fa69fc6be21e9e089b6b9737ba58fa04a3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e888bce04bf5e4b0c5c1721112cc77209afc3cc..c92e788518363e5dd9dc84ffc92f23d941314d97 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2023 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 115f630190ea4cfe3b0e04fea734e46538b7aba7..35703348f36e22c803a0bdfaa31e0a13f17bb49f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2024 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f42dfe2283e0846ac88a889c3d7e4ed06339b6d9..0eb2e241c12956a4e329884c797da28e3dc857fe 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index faba8f71efaaf03e87af3fb0d67d4ff4f7848793..e858cfc57abdc26f27383f39db7112900c5efe89 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2023 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8971aa5ab144820f7cc595c50a85556e83906253..cd7f3c7f678f2513cab8fb809c67beb96a902e42 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 841b52bfafe523b98d2ddf272e51028ad370238e..3b4195c42c7c3f9a6ae53734726518bb843d81fb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d67b0543476e78d7135e8603a5b1eb1058731fcd..1c8364cb414f0a1fa1ae442b506dd20c725355e5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0975c8f04741a13a0ab68da64ab0a2122638842d..d1b570513583f068f80f0116e2f9b4e14b8b1b29 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2024 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 123980fb9e17d90da1ddf0c74e109fad814f4f52..ff8490bdcd043be26ed3abb1262cce46f9dd3203 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2024 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7925c14e6f9abafc5f2fa227ce9bfd3cbbb83bdc..0b3f262eb3ed39b1542d73c8cae51d10f1ca0414 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2024 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87c37f192507f535f86527f541324ca0b38df90d..ffad78c788a9a9593d1c98175c1a35e88adc48ab 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f3e34922efe06fe3c90d1bcbf0466f22b9d99c6d..f912e73b96612ff888e6574e3a9253b2612f2386 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2624bd66d66acaaa58776ffd5a14b169786c909e..b64bb9cb5ffcaabfd6173e46f1128e112a70029d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2024 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 974278222b7d442d1ec112fdafbec3b13943df5e..47ce4ca3fa0c7a4a35c79f23c407dc09c9f20226 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37f02ac0b4deb650c23b721de09f1f4968738278..0877855c4f24fb5a67ac407d235b15ae0e1134fa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2023 by the deal.II authors
+// Copyright (C) 2007 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 448c37efe92d07bace69998a5bf59eef644bbd42..289e430488b2983edcdf846965409d908a9f0f30 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2024 by the deal.II authors
+## Copyright (C) 2013 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 8adec2405f563184bdfa5d839fb5b087a78b5b54..8f910a61b4424b5e395808cd5a81b37ecaf4601b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b8abba4fcd0cf60495201c065e3e3058198f9f3..73e8a35cf063127e97f166feeb114c72a523b0e9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52bb4f38bef5c86e2193706a3ded30fc9d96aede..a7373adb5353830a704c39751b2626fd27ce3110 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12a35888334d5be468a8b848d640da35e72f1290..ffeed247208f89d23e63a9554fb5d2566846a449 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf0da5ded74a91b05759540064a30704085282dd..56aa68922d63f79635e7fb1d7752318f5394be05 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 154ec25bee12c850e2cb59029c5a2a7f3506f12e..e73b074a2922fd8730701acfd9cad745f4416499 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c8db8bd856e976fd623b3cb90a3792c787744ba..46847ca6bc894aa21ca4d132440f2c1d68102373 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b7c3c231a8fbdbd5387dd416150a67feb721059..40eaea22a25494400823a73a34fd74f41fc6d010 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2022 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 491b32cfbe9676a4d95a0cf96da1004ce913782e..c6893b6088a323b2aebf929fd052c91990921be8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2021 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11ecbd51b373e5f6b6ceff35be8ba6de229ce3a9..0500403e309c2b961bf100204ae6ff903259d9f2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2bdd64c0b0d59cc67b6140c81907a235b07e9827..52464269bdef91da4dfe75bc8bffb4f0a7a5418e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 874a16082ac02d11d77742ea752c888482d39a63..9eaac3330a9ad7c23e42903c90fc2f8dfbd0f8fa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70f53ecbcc3a429a82b343baed9daa145a09870b..035472b090648e9087920d881e10a05c39d46f54 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8108baae57c2b99edbeee798f547325289de7295..65cfb2e7142e975ad74bdb7c41e5d5579473a9e9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a6527dcfa0a20c6a56616c6ea934fa3f5ed2d16..750e65c22bca661e1d59588ab81c79d7e76b0e4c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82a728f002d81fcc7e6dddb515cf7a8a44317681..7f6fc1d97cd187ef42022b82f0c10b2f7d550356 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2022 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11cef66def98d2ed8405ec23d26d38012d6bdecc..8a2e4a6092bd93551ae9664153bef5c6ed9e977c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b6a1178169913b343e562712b2c983e2455d268..91f568d4e881e284d4e8da78fc63a10c9c3d597e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 83c535cd7f305feb31cfce3b174df452d114abab..485e68842d2a2e7272f99a11a9cfa62bdfb61eb1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2020 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff02f2334f864e2f08882f62d03309aff0c8b198..17c53a50b3b0a3f1e164a65325e2f6b6f7629004 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 58b5f2419116210f0c5829485dbd89f535fd7aeb..9d6f89dbd9d3323132efc4bf218f905089f38da9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2024 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a2afe009cf4f211c8de12f3d01e0fda1d15cb3e..f11fc04dab89e8c021ae7061d4aa6ea85951479d 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2023 by the deal.II authors
+## Copyright (C) 2013 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index a0bdd4620eff86eca274aae39cffeb42f98dfaa9..5d2e729402d158d3f9acab8175a1cc2056e039ff 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75c1beae0aaa68769639dc3d47706ad0c7ac5a2f..838a3838c2077314d9abcf32e99afb62d71f01e7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fb5f449c442d4905c8ffc9a14a34a0d73ee22ec9..e6041d9ee307796164d37c2a0d22e1c9935a8d42 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12d9932847be5e612d313379fd53e81d9e547dde..8cc3fd587e1a42ac40d6874f77757ac7d18f7f51 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2024 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index ff49fcb82b4e65b98326ca73a277ac251e052626..b52594eb09430d34173242e5b00572c99a067ef2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2023 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 791e14a310a38496eb2f97ad5f42c5787a4b299d..73f00a4a990896f0abc3c42a9020d62c38b02dc9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70f7b5ae5c91a4d9f304cc06c70b187e9ff39f11..be3a22073047c6dda69c1202ca08ce23fc1b320d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3cbb47b81f870e5cbb8362a8e71e61eac6df2360..8398458d6f717d3cc654ecf06f197cbde9eb4044 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2021 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 700c79b0802ab3e120c4e7521efe04cd74b2a2cf..f15f8789adcbb95000495d65f7fbd9017dce79c2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 786622b1fa116480dfced35ec1982b1edeeb103d..2875cd33ef835e1a1044406ddeb3d13b2abcc106 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4f9f89eaef70934d7abd537ead0391723afbb3f..a1f3a78b04da03c3648d98942966083d9b9728fe 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40f1f6aa05278c0b9b03fd007245c4a727a92a7d..e5f83f81b758d2ee0cb31e4ea8c787600b9afb3b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4e40c0fdfbc9b58a26026c43e8afd09906d9289..f53b9494dd43459d5ead81750b4e30783555a7c3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb38d7867a8fcc724e86ceda9d43d5ed04af3970..31646ea99c340ee69832b87960b618e23e5d2092 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c91431583111e71aa93e33e39bf157e9690a44f6..5174a0b4bf12151675c30713f4d07ab05f9ee9a4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 457e96af5de60ed59ed46edf3fc6fe55b091e26f..11944eb87ad6725e2e45eb29daff3da8fce28a68 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c29c81f22880731d7a6e5f6f545e6a809c90868..e0bc0fd7008afe0e0ef79d9b646626e7de2983bd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2021 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6584299dfb3b4b0c0d0e29f9c14c0055851a601..04279b69273f2027ad8020825202fe72dbc39f12 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2023 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d4bacd489b5b664a792de36787b6c4f4aa8807e..3379255b5e7c7dca332a4aa17139984a9a0da1e8 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index b034da12542e5932009e77b222ac6283ed145aca..467d36f49c6ae62e3e7dc18e3c1e770716a62e36 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f55ca9287a0a29d9467397ac95cf0227876158ec..18a17dc77e72b212f068674fe995a51b753c177a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5f368b8bed3e071858f0e87e04a6b0c0a6654ce..75022c27942049431fd5a22a7aaa6fa96d019e3b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b1f8c66891dc811ffd3e5faae89213e27db2499..2491257260f8811e906f18f2393aba285d462d50 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34f733990d44b0b8fb454904cf1abfa8c69da1d4..117feee4e737e2164dc49c84d9af802a9c970acb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 61f41cb55a97b716825cdb1b20adc7c798947ea6..e79706f532b7ca06d147ef2a5267ec268a90e7f5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef72800b84abc5288c6d259e86663f6a3e9f5823..4474274e1521c21f6b558de3b4037cc76c89cbd2 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index a131c16ff711a9d49e983ea7a68704d6a39320c9..feb664e18ce118408600df43476a15bee48b483d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2022 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f382d42159f8506512120e8e5727337811d771b4..8cfcde42c695dc2d222e570a6e46c387fd29bfd4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 891a63947b1136683615bcaeb2fb8b31ec1bbe17..e8ca67d31b03221fe600f4c50b064f9d1303788d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95018fef7058defae3c6e85f5a411876f2de4ab7..a7229d5fd0dabb113ff84c7211d9f41ec035e916 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc1ffb7b957d9144942202b6f680c0b711e81818..482d830bffba642666d5418408200c59b029d268 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77029b8df88772461ae1f7f09827c1e7a1fb9fd8..42848e3aedd4c3f9c288ab0c8ef5f3962090e587 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2023 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9107745f7187b6e155b60e3c371192ea2f49825e..bbaec869fc481d26ceb4834f387706895282d47e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4156c7551729355b2b3f0defd44336e0b045fdf0..fd2524f1c67787168d50a2bc2ed95b5ed00eb5b2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a8cb06a40dc4daf2c331c1941567da3dcf99b6a1..d5cf175567085c6cdc6aefa108eba3eacb971e5c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 756df257e054629d463fa59434978615aaee270b..8fbb0be7241293a4f39ae0f1346d7eda9c8128c7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2023 by the deal.II authors
+// Copyright (C) 2007 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b6621b12b4b651e42216cb4edced50b617cd0dc..b0eb2000e82f0b813992935c1904713942e41489 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2000 - 2024 by the deal.II authors
+// Copyright (C) 2000 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47c6c4610ae961d84912ca6ecd21ccc683e4b658..d1809220b513b8ff9d950cbd64bfffe53222f3b1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2bebe65fc3dbe9cd1d31204d2c57ade12fc98258..0f48a3f742fee1a6bfd3598781344331f784919d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d94611beaa986b71582edcabbb71b77ea016ec39..ebc93cc7f828d87f7de410c1975e440629d8acc5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c01a00b0074c90dc73a38022adc388efb322fe7c..849971def0f6e82afb1be71e789dccdebac2e1fd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ad158776cf9d2f1d2544a924aeb8b7238cd14c9..dab3890b6b460c25c66f8e537c4877535e143b9b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2023 by the deal.II authors
+// Copyright (C) 2007 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4160ae96db1ad36be4c91bbb1a624aa5b3df56d6..4ef6da6b9543e078977ec585d3527bfe9cd2efc6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e22e584766f71b7e05df21f3912199161cf114e..2412f02657434301f82ccc1a0e20375dfbd06a81 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 779578bba2aad9a5f7c0901827646177be0cecc9..20f13cee9e9fb063cf2ab1894b7e1fb105a2563e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0d7779e536213bb7b08083241e8207093acda35..baff47dab83d6d7da43d3c296b53ea38b2280f41 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2023 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e02a0150c1f5776e4d50ace4a246ec45fe7e9f3..3961d75dfc101f3da84e0e1574fc140c5ad841b0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 51f7bafa4769c2723db6bcc921d77da35ed1746f..0d344ea4895bfb2df892d45e69496b42bc93d913 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2024 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c001bc346b19b8c1fe73ef42ba8ecda88358b89..6d8f52821ddd679d5ccbe01bafc42719fabcceaf 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60b8cdeb63daaf1eb59c960ce817af3907a34067..7279fe918129dbb5d7beb8b2ac11ff07fd030ef1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba92230013d9d91daec7487b3ce6de374e61af9c..72fe13a741e8497f23a42cbf000459f0ba6d0529 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2021 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60a0ca8974cce10f5ddff79137e08407034fdcf4..a2468513914f5f30c8ed75f6c76c697c6b3522ed 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b54853ca0db76c24b40d4fa612fbf86c30f9cce..059ecdcb99e2033c66589a6110bd8f7a8e9dc288 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f096f83bc6c46a80b773631c3d02de42d43896b..a8e414d23d2f363e050655a09698df3c9e1c9dbb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c5e021456d296dc2a477f3e532305aab7a8cac1..511a72cc970e8a518a696b14415d34087ad94ccd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2cde841c5fab1d947a95cd4813bfec80dc6f5653..b9b58cbf9016a1f9cbf657644a1b91fc5c9f312e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2020 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 265e8be519a138fa4190859b39a2f0a89c6492e6..a067b795d6ccf2efe5ecb37c3cfa2453265b0bc2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2020 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3707e0611c3e7c41911ee7ebe77460bbb449f2a8..a8896cdc92df2c08903848aa8d7098f0db57940d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2020 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8963345c3dde824ce435261c8506b3e99809ff6a..9f22089ebe8b2afa51f34ed3a48a5516a9f9ee72 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2020 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb538ecba07b0d77dbee84da1e3ea62716ac53a8..cf585a0221665d40823555e46edfb8ab02792be0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2020 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ddfd01bdf3e86a1912a046fd667dc489112d6801..7a6baa18cd45088fd104129c0acabc7df1e4afb6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2020 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 307c56292f29b7d942d3eeee31dfb10892487177..52aa362cbe8a8fd7a52f4e1f8334f2666e537270 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2020 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd5f9b874e48d25db767eee6b21d4c64db97a112..aa6503551229231669cf8f88d657245407327c66 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2020 by the deal.II authors
+// Copyright (C) 1998 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 962c77d726c9ed87f7839072833680bcdc954bac..07e57bf29f4ce45ee11fceb3a2fa004f41aadba5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2020 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0aee4117878207f3d059919a9cd0e4550a3d9881..13d6610297ac2f3ce3ac4b1b291bc1cd2692a191 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2020 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5d5ad9d3f36f68b7fb86c7b29cc456b1c06dabb..3acaaced7fe41034afe6d66ceeb929893ccf6796 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2020 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca0f167ea1e7595ba734a2888155750b0601eaa6..f1456e1ee8e9659b101d2d766fdfa774ba81f075 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2020 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94f0c70e23f287e0c6c1f81d6cb6612f9511e0e8..f0d3b15cfa03d9d736c4980b8e0544c2a43ff9c4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba2447937309a536dab90453c41dc348664163f8..ef06bf211f6829f52ca01ad41e23a3d6d59ab787 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2020 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 46f57e28acf85bc1420558dfbbbc665a4eab20b6..b6d21aef7069a9b566ed069addce6bcca8cad3cb 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 44006b00c789813efc758a6d1ffb4298a0ae1217..b1febfd5424de15010d4c71e10a2e696f0c79c1d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2024 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9718a8348720d46d5046de0a11a0c0bbbc9869e6..0e7398a102ff98d5a8463db9911bede4dd24ec08 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4c78d654f3280c77351e44c668fe3af26fbbf3f..da70e164149a7a48eec884775996412db4f9c2cf 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2017 - 2023 by the deal.II authors
+## Copyright (C) 2017 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 453ba833461056977dc515cd509c6731add0c0d7..a8215825d8d0f10b3e7a1ce594fd6d42af70f353 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2017 - 2023 by the deal.II authors
+## Copyright (C) 2017 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 22c7f889b72572c42d337a44e097b039a683624c..389cea7131eaf8e0eb8d3fdaf6445ebbc8d1b938 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 49035a907c8e64c5a2f9874e8b4edd6603174382..426670dfa1df92e693cca788626ae91aa57beece 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 121a4207ad310053beb4019973112c59e85ec5a2..6efd8e397327d737172a74fdd47078e1db38aa6c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 58f9f4a84a559c6d85e74ac1bdf5d805c9620500..f4dad9882b9fa3833b7c4e0b0368aa3544a455af 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7428aca5cc7da190c9eafd1b171b7b469a619b72..5faf6c2ca4e82b15ff9910dd4d16acba01b6460e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74a8d85b99d54e374770e183c61bd65156086b42..32582ff22a5075e23dd270d101b414b80a53618a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index acbf3332c4179ff87a6323069769c41abf884c80..2438ddff2d5c01cc5441b414813762fa32cd2e0e 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2016 - 2023 by the deal.II authors
+## Copyright (C) 2016 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index f4b8348877c99c3821e135cab23d197014fd15af..2b9809949bff7a286eea497a1beac26473aeffce 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2016 - 2023 by the deal.II authors
+## Copyright (C) 2016 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 757eb3acbb01aa415b38f844da524728c0c5a823..9d354ea9f30dadbb47b286417b623d83cecc24ae 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index abce03a7354699b6cae6d422c90911663db3126c..975206a6bd966a44c37e99f8edb67faadc1f54ce 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2020 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5c235f6ec390c1b6fe00cb26244f519c516f39f..536373a2eed242922aedf91c08a37cfa4d757f1c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6a622ebd55e1a54551e69d04544d0193068681a..fb7d3a8c00aa5f9b104703f5899303a2ac8cb202 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 3e3844570bb65577d26e367b3e9ca16ee1c9db57..dd1d09ea6041aee811da53ae491eb6b01086eb0e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b41cfb10a4d0e2fcbcfab2bd942e649df1c46fb8..f68e16ddfd888867a34224f2ff0355129689cc16 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5dc41c569094af77a7189107a56da6ff02129a0a..20ecf1d474a9ded255df333a85407ee1ba4b81c6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2022 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a457e506cd8db6b5396781441239597711822ac..4600dfdeaf90d56dc1d83d6c2d911d3bf9dc9bf4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc73e8429a64fdd1cd9da53396ebee6ec524f505..414336bda1b6b41f5f16a7f995ba5ef25f0e6cd1 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2012 - 2023 by the deal.II authors
+## Copyright (C) 2012 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 5833a86aacd338c22c6b233683ab5378485fe81a..e75c3c7a2de5cdd8b52eee9868792cd466c297c0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35fe426cb43bcaf2a94c84279436f67b4204638f..161ee75ab315dd8ef30a72cf96d251783b00396d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2022 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68a4a56f89e190b9ddbe000bcde269148dca750b..d3e7d9012a58ac3fefe626fe9019f953a1ddd26f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68b4b57c6c190ac4b5c560bb2306d64aa40b444f..e5ba8986455583dde8b3aeccf200bfc1ddd29db0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42bbbc2c4f007ffc17a24bde9c94c1ccc836e427..14075e681b49514d5f442ea0ace6ff5a982d25f1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b808efbe0c9e812ddcf5c4b4bce6a25f62133ff1..ce51e330624845f4addb3afd4bd5dc3a3d35bc2e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 865dfed0a79476dbe7f494ee817aca155dcee614..c351a4533db210f01d1f53fab3cdb0fc3f85cc40 100644 (file)
@@ -2,7 +2,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7be6f3cbabe15c2084396374eb33e655c594a30c..a97957418859cd679db6d02091a7a166f5ca8027 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2020 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da1a106b7b4b9802b388563d05691c1c04782471..465faa9a25978f33a1db2628c60cb8e54cae29ae 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2020 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c33f4fc56c898980f07a4ec68e06cf3f910404a4..7efca6956d10e6032e5dbcf3b14ec212eb7032ff 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2020 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95fbcc4062f8ed8499d8320e7314113103f4b3e5..0641cb1f20d2e9271ee9d0d9ae73a9e631859e71 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2023 by the deal.II authors
+## Copyright (C) 2013 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 1ad6174712dc76185fa37ee316ec96b9861740eb..63b47246fc51ada684856de380b0c819b3e24a82 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2021 by the deal.II authors
+// Copyright (C) 2008 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64c7a5d8445b3d852d2a91761b6bdfed713cbd67..54fd8e8f3831332e96c83ceecdab891da24bbb45 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2016 - 2023 by the deal.II authors
+ * Copyright (C) 2016 - 2024 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 81a3d9c38de63ed0c5229aacf9e9703fac21cd9a..2abfdb93cf24555ec04435300f70dda02547ee73 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2015 - 2023 by the deal.II authors
+ * Copyright (C) 2015 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 73cb2b1c8803eac752f028807ff2fb573717b320..ae4b9af7beee3649842514e8ccc72f674d5bf262 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2015 - 2023 by the deal.II authors
+ * Copyright (C) 2015 - 2024 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index df20ca62a7755d5c45e7fa08a7461c57023d5053..cf8ca79f3901f7e3b68c905981d5ea7845fb7173 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2015 - 2023 by the deal.II authors
+ * Copyright (C) 2015 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 6d3b748b383442bbd021d3c0d5d8e6783c7d7549..41e8b89b93756d109f38714ca0b4cd3f08aa3639 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df84f1aebb3895b7acd287319955e5cc5eae3b97..1eabb877e734e63e0536ddbdcb6dc5a88fcb8b0c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37684bddac5ed2a6ec7cd61614673602f33f6849..15467608ce87b05e2accc3aad6e12db7719300e5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e846f75e0ac666009b01f376761adb57afbb393..58bf659beac11e56e209c5786b6f242857ab127a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2025 - 2025 by the deal.II authors
+// Copyright (C) 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99661633e1dc1d11be7f97de6dbf6f74acfd7027..4d9ffd699c08c48e7569714ebfad2a7a6c72ad26 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 403fd04613688ccff211459faadfc063132129be..a9c11acde06ca405d9266e21ceebab3f2b7b7750 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23ea12b4043fc4936cbf49eb72781fb09f71b842..72f0127d9620fd89b7aa139127b3839813b84876 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 29d718b1fb49e3e658153a0617facc913be9dd80..dad66c6f19704213686fd4f49cda006f573bc82f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e36c88b96d9192a809c2f7fd20123ea1ea1f5bce..efdddbc67d5ae786b81e6001e44d9f5f29b5ceb1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 24d0b3de1fb4f6dd64e00477c699f3fdabd19acf..ef11e30e8a1c153ca4c89981fa194e0fb233964e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2022 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8b758a421cb588e47ffbaf875cac353a186863b..104c82646d45d956ca46d3767be037c4845aedb9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2022 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da1e96b59e54dde30d8356db66558ba89c0e69ca..1883d98b0b199183adaf8f5c8a6a1a34c0e5651f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4585e3f5ae463c894a50838a7f20b5c6564647de..5ece5b29a74146be74f4922de2ff940ce0b9519b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2024 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b9ccfcd709a04a2ba80ec80d90af7befb306e36..9b7982c0ef883e9391c0c5a2ca30372eecb38935 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2021 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7a69a6e7cc62f236133e8a948a08a9bd3f653535..d46e1609c049875ca4019470c81da46a1c17771f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2023 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8a9d9d6ceae91b2d2245c8bea29d32f8d7ec7dbf..b4d9deaa90ae099e92a9de00c441bafad36a0919 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2025 - 2025 by the deal.II authors
+// Copyright (C) 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff11134d213083004ff8dd896cae69e247fc7a01..f92dd313018ccf48edd5ce6a9eb590f9bce790ab 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71c228ba2e3229cbe19cfcb68f261914c67248a0..b3e0ffed80b3fab351f540d03deaa39f89324fe6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd108241430b45aecb5de16202391e648504c62d..90a149b91efd7a63b75fef56f56f56713c65253e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 754a85e89d5b5743ee106932e26e3e14175ee25d..be1243baba041bb324446d4c7725c391f23671d6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6da571f4549b0e67dcbcfbfd21941e6788fc9ba8..6762ccb97797b7bf6712eff490364b10db52044d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2020 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0c5fd2c3589161002ad965fd6fd91f21c508a4fd..c48605a2df9a41ce179cce23db229bdb802c8e15 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ba815583b83e8685b8f1b91957ab2dc09824c54..504f3dd850fcc0cebd3d88aa7d2cff8fba42ae8c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c1dbdef568a7cd215d0f4147412b2aef1e6e61d..6aa12f054ee72b116c0e40d91d771ee030744201 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e227d132dcd6a7256c54bbba5b734f07d3179e54..6f59e73f18407f29d8512a958d515054980e12d0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2020 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c160d9c93b6c8079fca4310cf101d695c767a09..f877a7c6edf981f665114ce9b1aec90f2c01b2ee 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2020 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0bf4f56e87f2c83f35d0540d898aef3e0d6c7e5d..5cfab72d9f4d5e249a8d85e04a39d20fba782985 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2020 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b26d8a18b79ce678f1a8cc59c4a62ec14aa752c..53b698da7b23145a3d04acb9033f2eb8c98be38d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2021 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b996d40b7c067ccc75683999f7efab157e508e1f..21082c5e6e7ac4d29f3134bae6cce473997e155b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0be4abab95250dd3e63439ccfb7d38d624f2e494..566cac0bfd6a4051e75ea72e8b5e845a7d317186 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e603c3d7362de09273bb3655d40dc8fca08eb5f..307d39bfc6cc0766df2d79ba2ccfd4bb07c8fc1d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5481eda0e282fe36fc9a112bac6cccc0f14ad18e..1d88f74cefe71ac5c67f9bf02a46e2a55e4ca45e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index efd536e8dbf44698281563079fc9d68a38b21d7e..e55fa952aa5b1fc1c5d621c38c0ea640051df4c7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2022 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c995eae172fb36ece66ab43e63f32e0e71cf02c7..025ad6a93d83d250c4d0cefa5799d4f738f2b561 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2022 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d0d0f4ad369e3f08d753d304b9e4d65dcf1222e..cc79aa1854522e6c39e3f4485d0cc962b6cf20bd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2022 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3131371b89810d3b534189ac6a979e04cedc94f..299f8b8228261697a81ec407c04e7b000ab5b520 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2022 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b47a79f9fe907afb86a74649f21221f79825266..79c98268659c4daff1f624749bf8ed781fafc944 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2021 by the deal.II authors
+// Copyright (C) 2008 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 44364ca7ba85e773e52d8a9d7078fcd51ead755a..46c574291359b7e4d02d5f89fe51dc0d7faa9804 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7a66109f4124ed12ff3f135f66ce652ba18dfdd1..788c7a4ee19278bfaef32594df900322cfd2827d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2024 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f43d02f8a6b50678fd2eb17d3ed1267db7690a2..b751b07c832062453151372d5fa3c51200dd7616 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2024 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 122f9f794a07c9cdb464dc8f5ecd50ab0c376834..854419449041855713f01339680dbbe4548ec528 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2023 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 167cc5733573d457fe0d29a2070183d378bf0889..a8cf25c868572efd72527d1fc547d48688c089d4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 62c092b81e67e2ed885de026a9c324cf1676e282..2918b41f73b849ec59cde70c66b3abad6c03c76e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 
 // This file is part of the deal.II library.
 //
index 76cba9f70f02487c3cce58b11abd5817a8021e01..84158e79e3e6d15d4f417121a317079f6416b695 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 
 // This file is part of the deal.II library.
 //
index 4590ca2002827e022b62d134d70e5ec0aa3663aa..fb36e61aada5df54deb6bd8182c47c65b4563303 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 
 // This file is part of the deal.II library.
 //
index 87773e0eceb4babc1b34b36a24cac3ad490a307b..83db2be356c152f0b3f38a6c89fd749aff3afb3c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 
 // This file is part of the deal.II library.
 //
index 4aac056708098ae14bc3f9ec31d595c3340ed4af..838549bee21012b705cfc74339afd543b13506ea 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 
 // This file is part of the deal.II library.
 //
index 7efa5c1e5e1bee4aee91bdf6802051372fda1891..d28d527bb7f6ac52eeb0a69dea43ae73ccdadf1c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 
 // This file is part of the deal.II library.
 //
index 913bd8292624cc7eb502e428c84c423c41f662f7..82a38de43e82a6a23af8fe9514562cc0c3248a3a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 
 // This file is part of the deal.II library.
 //
index 44dae38376429b5850802abd74c4ef5f4cd9453c..de55c48c7f75ae901eec00f43619025c43f182b9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index edd9b94b418b05ee23ccd4a7f8bcf7cf2b5ed388..a56d39e685e8b7cfa7736118a132ba2207d0b184 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47475d4d6b9164ad7fcfcc771277d6ab41ec401f..a63fdf5306311987b2f270213ba9f501d682ce57 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ffda5beff0f513a005683ffc031b1253a948910d..1ed4e7ed35b2a44526fd84bef2b4fd7f21ab9d6f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9878333901d34096b7247469536b6a133e4e1ed..9ad84d465cb887ed740b1d5e13b9cc9d55333e14 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f05e16a0cce3f98bcb22f7db49f1587e7630c48d..5d837840ba7cce5af042e806e2304fbcb05a8e5e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a7300669a70fdd25ad61a2ad39d095054a9ca0c..9e107271dc04992f7a22b44ce7b0c697deab999c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c1aa51bbb0c0cdfd178ebf1d191b57e94f5d74a8..7a3384cb5ece4609c33f20c2337194a32726f7b8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 305ff71cc9ae28ed46c0a67d18b167ce76acd29e..39bff71cdf5aa2a53f28bcc0cf4eeed8591b4bcf 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 247d5d6ac19124c09ece57e1faacc4c3b9d91526..61365b99ae0c5d0d22030b45c8d42890f69b8c2a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4bf689287befebbfa797841b6a3da93b3d2c28ad..7f1f13bb72cb36b5f7b2f19c591711734601c444 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f860e97d3f174dc78d163f3810c60ad472abfcab..80c33329cd136c48505f05bfd7cf1898a2df571e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 15b22970c88bce7a6769154199c316e181dc6ad0..fa9ae7dabd458310558186d673bf425b2f8241a9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50715366078e11f6d1b8cc24a5a447a5f32d9475..b5510e6268a7ac925787d7fe68544b6ad43f9ac0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1db6a172c37f08b288abef9b76a154bb0e265267..318073869629954300957c8658fd292336e4a479 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ea630588d0c2b2d87545aac7a42c2c51632342f..6eecc5c0b1f9a2e40f5ecfc49428f336faace2d8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5554da92d204db66eeb71869448737d9c2369c8..82fb751ba0f8269684904f7b2b481d42d9abacd2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b7902f9c65575ab6268e6ef4db31a8b65fab634..b8b531618b65d957f06f19dc89064384818a5f64 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52e272a592ff8ede4e75c8845bef38ef840f279b..1ad0d71ec27da657c5ee5c2d334c242e89a63d2e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0dbc8ddba3b1c0ffc77b7c15ec14968a6bbe050..83824315b01b6c9d54285fb78cdb9025d573276d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c5bff5de9d4b97897b88c9f9581215e9b1bf5c36..aeb946b772c815d6de7f11d3443407ca3590e6e5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 78e68bc1e1c9d6de8c70618aa911829b6c115931..8ac90eba396d29c172a4d03c8ee1c744b6e203a0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c22b1b7140956feb656d1feec551096146526bb..afb46f4c82065df0e84cb4b61c0b331fa31efb5f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2023 by the deal.II authors
+// Copyright (C) 2008 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b2af65205d3f4c35fa2fc79e8d1028909f4e558..e8b4f53d4cc4ec29db6c9486256d474c475f7aea 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2020 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 44891b212389177f231ce4e381f612c453dedbca..30611d6af33399ae1ddaeed30ee35cd7ef989eab 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6919afcf27cec2665a20222337f44c3119c7dbe7..4c648c0916c8824d7a8e363cc1c8e7d651514700 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2022 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 584cf1c7921c5299396145c1709dd90519ffe1a5..0ac3e91984dadbb1a044154d2ba7e7d37f9da2bb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index abbd37297ffb7b1bbf211704754e084821b35f5a..477d0704630c1c815f41d9ccabd3a3afb7a1b43d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa45bd015fa5b3a53b421b11e14ab5a0f79d8077..f6c347e69de064b2be33bb791bc12889055ec52e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 237ea34e96b573323e9e7ecc8148a47a7adb03c9..b95867dc5ec08db6d2407fa95b50a36dbc397e68 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2020 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 561ba7142252ba5f791818eaebe173b7ddc16808..bb495d75041ff526d6662400fa5d77185ace33e8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2020 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a33d17511e0a785bd255474a945aa6b67e48b54d..ae5f9743375e79e7db9d02acf8f2bc9a2452e29f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 857173b15730196a0365a8aeceeb89b9c3b78c7d..07c2565ae6db34788ebe707cb323249486581968 100644 (file)
@@ -1,6 +1,6 @@
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12947df1a5c6d1983c7ac7c34b75037d3f900632..b3ec00d5cc4cf0ad32050819f93ab8e78e016e79 100644 (file)
@@ -1,6 +1,6 @@
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2020 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f394b20b5eabb7f6a5af10cfb253deed49f78a3..0477386ec402e25d466213e3634b98dd340638d3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2023 by the deal.II authors
+// Copyright (C) 2007 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0996a1191f9c0a31fbb2a73ddecfb139849c9d4..f6e128f00d03ea8e87505f691cb711d13b70c792 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22e58c02fe7fb0d24ff68b31b30983035d91c742..8bee64565441af43b21c4bc435aebac70c672468 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6ac2f4060c328745d97712eef7b4bc28d95c647..eca68eeeb2fa497dc1dcec3238fcbcc03042c77e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1c83821457d79c0d78937c0fab5446c070103eb..704a45c4ae9c0385518e9d8253c0e7a94e4c83b5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d2f791b968d96df5a81b8ee348a37337f20df913..c5c01caf04c814d1df01a1eb890c6fcb5fc8eed0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4c3ba790377b16560fe43e4e338b57ea1a663ab..14a1bdff3eb95cb67006631a88dc5b846addd2f4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c13336f18abb5ed10e34e3ee8a0de16c98b0dc23..98cdadbae54b92baa5af42de75548e85db7014cd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 - 2024 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 795c25a97031572b270e2cd5682eb0f9e1c5a925..65e4e421897593deee8b247614f2a00e66df3deb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fbf5a332f36ffa3781ea5c6b99004e791a0121d5..6214c5972ed837c709e678b88599bc0aa84d2dde 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d07432acd97367205d09aa4d8f3cd97b67f4aa9..eaef8b172ac2b853cbe8f6ac4dfa33c1518633a6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2023 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfdf64f85a98afff732690ec28c323a43ea56892..4a45fd8ee0117358ecc5fbbf345da49535953fe4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c2b15e4fcd22ac1e12f7feb3628efff89c89c3c..7fabfb1de9360786358b45dd93cd7435ac35dd21 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b9feb420c8d93bc7c0c8e385db3f71d2a187996..a4a1525ece97860521ec2d49d6ec6ecbfe8f69d5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a3c947e4c0139b5ef11e7e2808eb548f279eae6..56fe1d187331b4f62c4e0cbaa57392dccc074f3d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa675c15853a8ef6c378b699a68b4ac31ef4b85f..d74bb7261e6ab0adffc9ea86453f8d642d886515 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff3ce03dbdee0e4bc88f892b56be0ed52f7d6757..02a0f9d7f4ea610aca616704a260ff54037ca049 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe83418ce0184f2513482fcbabfdda1f41da1355..73ccb62bc06d947defb36022bc92c494e67719da 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 848fdbd1404c13c11164add8e7f6a8643dccc61f..32bad7e775cd0a355664cb33fa7407261c917fc2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2021 by the deal.II authors
+// Copyright (C) 2001 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca05899b81c03ea89c58591a6dc85f0b5f37cee5..868d9d95121a0e62fabf692617513aa6b3fbcc98 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f871bbd48604cf9d4f4f0ea83805a0aafeb1fed..e6a96d5ecbdc530aa01b4ee5a1b5ecbcd6e2756c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3cd510c1931304109bc9c5dbb2d8abc5e8699baf..57c00ca12ef317b3454122535d0945e61071fbb6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 242e58fdbe0e2b3bac7d6cb267d3638e5874e9da..64ede80787f7f76e303e4cbf29f4e98a17af0154 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index acbc941177b4d42eb9e077d8b1c638b0c6eca9f6..af6d6060378ed93887faead37c66a57057251477 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64b6be3b846e9c0b7029358a9c736d62ead424b6..76fb09ae3bf6f2b19bd9bd10e83a165360a979f8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 445ec81a02b617dc8b92900c2c8c040647ac41e5..ecd9b8b89903176262207d853f0b97ed5184e879 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6097be34a0be7136b74d5679749d61d1e4bce6ea..40a587cad803e0fc0344a733b077e76415f516e8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2a037e8200112bc47c948d1c6a6fb796f9797f7..61d21be197609313de0dd927d7d58193ef8508a3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 464a8f2fefa16c8198f864e684f5ffe0dd75346d..f4b14a344468b1f13d4d9932ee250bda70336f0d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1bd08dbfea334a6433d507905b55ad665ddb4aee..54def9a9e013e74f5f63ed14a8d94b299736192a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff859f142312861539e168156c14d7ddf1a95687..656ef6ab730f119f1fbb0488267cac6c6148cb9f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 647c351adf3b672da66f8c86b4c13a5ce34301b0..d3ee3e4f36c4706cd9aa199c5b930a160077ba9a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 955d9733d27906ca23005a4b29210bc07caedc69..75702c065799a58e2c17fbd3f5ff02800b0154c7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f35d1c2df7f35fbc91d1261f46912212536c49d9..7cb772d4e8f5fd57857283c1c6dae8ab38fda4a8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2024 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a273e46c5f98bcc10e6551be4722fdda829deea2..c6c5f8b24d23236580dad9fa030d8116f25eff30 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9467798bbd337e8ead42119c70d822455c00c47d..7f02fa79c23dfa1a4983a738388d8f912c04d6b5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2022 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a91020217e45303bd4e5cb8da093c0db20a89f5f..af8b8ac8232917a691cc36a985d4eb57277afc82 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40a16158876131df8e1881c7a031e62bebcc4ee6..dd8baa46dc61492772c06da0a79acf10e7eeb909 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2021 by the deal.II authors
+// Copyright (C) 2001 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 51f9c2779198f6c8a33aa3187d84894177d08373..bf277b04e5847afc07a42266ffe1bbeab33822fc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2021 by the deal.II authors
+// Copyright (C) 2001 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34d1fd0f955d68a6084bb37a0071b7893c5ef93f..bd26cc3d5e30ed7c5ca4ecc0838f665780cb0580 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2021 by the deal.II authors
+// Copyright (C) 2001 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 615d16d6b9e63fc4cd10f0218b0e3ad94b8e3d7d..0e5c4afe38e26abe9c08e2f06aef242d71a49fb0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee719ac73a207378becf79ec7cfebd1ca5534472..39982b67fe568821a06dedd58cc1e53f9f137a46 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c01f55e59ca258614d0ffb5294aa7d234841c8a2..05075065076ea6cd901d7b6b26e3f1412dcec608 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cecf865a0e711e62d5edae3e3ea05489c971df8d..e4b250c647b1b2ac8637f897bcf46617c539947e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 273c7a0553c036f6cfea3e2fa7f3c560729679da..bcdd0ccf177a15390d92a13bb57d630fe6fd16ff 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4712f3e8b92ed388af9763ba4e73a3f5937ec020..9bd5c7f106ce46f9f8930300c0582123ffab8b45 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 994118b8f68998e643a03888523de43ce4c4981e..a76f183ac83275d0e9ef37b8a3827990a17663f4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ce89d705012abefdaa54acafc0f22a12f2d4b03..5772af0677c898c0850bf09e8fdbc63719ad1124 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b2f19d680a5feb7cb5868f46fd73c5cb7fce6dd..c97a2f0ffd02745f2bc582c5a2de691de25c7aa6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cdd7bd8aaacb158666f8e583e66310c590c98190..c3cbe93de6df6d7b35fb2df253b6720b98ac6746 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a9cad09d8c367b3edd18398fb6617d7957b2603a..e884eaba76bbac4e9f651cf4eb51950f5081ca1a 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2021 - 2024 by the deal.II authors
+ * Copyright (C) 2021 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index ae3189cff43d69ab484d168deccd031fbde72b22..1958c443d3b06156ce0d539f0c1848a14a4963fc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ccb5e38911068f850191fc1806332575aab22e95..1da2022a80c92eac408d5be97e3c7af26a1737c6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2020 by the deal.II authors
+// Copyright (C) 2007 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index acf377c63acdc89b8d9f2dbfdcd489424422b6a4..43bbe8e3cb00844d7fa96768e2a72a801f3a0cbd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2020 by the deal.II authors
+// Copyright (C) 2007 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 02123704ed3db801536d5da017bed475d5293134..c87f5dca71eed9f324b596e48b4b394d731504f8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2025 by the deal.II authors
+// Copyright (C) 2025 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af4cb6ba192715b1abf887c5e1ffbf8436598f08..8464f1d2f233d95140f375f9012157fe8e1a3028 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2020 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4807915af901a384e839e59d9266f0e1ea170be..9b384770e1569f0c55fb850c01bd723d20478c08 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2020 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2022b03b0a9b39b2d4ce57649b956009a7ee1b66..316ff36386b407159b502ddb85e79737bfb35257 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2020 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42e95597d789158fd5a5b0e6e23bdaad22fec590..3acb70a322021299219d075ed56a12371b72cdc8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2021 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 270dc511ee4b860e0c537704072924d8193bfb9b..1c5ddb63f79197af56f0f85c6ad17385f98055bb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2021 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8089765de7eb9304e6d842356b2b044f216ac7a..4126fcaad58fa75495be59c1ecfc230ebed5c9e5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 033017d7b7e4b182fd70801c3ab46263a991f15b..cfc3483f20f252d4becea4053211cf585dd4a41b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d40812f9ba7ce23b712473a83be5b9da50c9e0b..5491b2744f62707b37f7a851f14fe9055f89ed2c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2020 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 65fa49dff7e7b084d0b7d130d961450332cf31a4..5148080ac098ca6771a58ba7180a749ceff4ca11 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2020 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index de69ab6c9141db7592c7a4abaaa539078c8b612c..a4b6ee7ba4945a7a98ea541c136ab94faae5718f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 44303d3d87e806f63d9d8131492f3cd2c2ca588f..c7d9a07e805a03e0e1cc28e6a005cf186063ef5c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6f16a2b709a13d846c24849425a5c29ba6e0302..11063436757cc6128776dd12a888483c1b6ae191 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2021 by the deal.II authors
+// Copyright (C) 2002 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 759b5cf3c3a29d79e4cda46e29094374f141b2d0..48d301b9211fe4b0d6fdf59ec7cb3b6977f90b55 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0766aebe84222d769cf783a4febc413cf782f54e..443e4777cbbcefe38453a643740b72bc23feca63 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70e41875d33c1f6ca3f49351d0e5ca84514038a3..d8a544a0ed87f43f0869d4ced783ba9882f34943 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2019 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 433b4642644f00e1eb9ad7b0cfdee3871e11b3c8..f739bb8afff15e486c16ebe5e4f7d5ebccf08ef0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2019 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cefa66301a069514cb99beb0264a32ec6b7ca60f..d0b89501d988f60cf3bd6374f78716519048777e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7687337c50411495d815e6eb2cae566f193c20f6..782c5d31ee46362442ceb7625dfa1928029b83f7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8e14dbf648cc4d3cfb22b573fe683fc3e8c41ce6..566d9baaf779eb3fd377ce703cfb37e5254c9d9d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2021 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a4bfbc455a210b48eccd6bb286fbfe5c306cea26..a64f61b3a7ce99380f3fb033792d8b3c39b05d22 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2021 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d4bdb350e59e95c8754f8fa2c6bf42143e3e7ea..3d27aa277d8c0cee6ad6ffc0e05c590df0a84ff7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cfddaeb55c0f2abdd616097bfa2be4418cba6ad5..9769fe47c04a2ea0fbee6d6e753eb67f06ac3d99 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 537fb26ddf59f14c8e87df00d401bd74d9325977..89e806b1b24f80f137ee168f42588d907b263461 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f09557b514f42de685b4b13fc2a98f07860e948..265f270bc36a1ac6399570b9ed5712823726abdc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2021 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6e1443fb3f76d11bf13bc41577a527972d473b1..f2af263f73a7b19a4ef3366968da577f46b99d70 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e4bc9dc9a8ba553c6e782a95f0535393079e5db..71c6202cc15a7bd96afc08811ba923fd36d4c944 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2024 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d3a73dd513cc60641c0d908d36016b0b126fdb3..dcd6accc579a50cfa8c37eb5297a8fe2a4f1f204 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6725aaa1f32f1c55eea57d89cad9018e2df3590f..ac02238bb6ed0527b580a40a98d3664ec627b03d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55b50b2dace6edd27a50c1dfe8f06ce9660afba2..bf37dd7967786467876196659cb79f094c6f6f78 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2024 by the deal.II authors
+// Copyright (C) 2024 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a3421cd7f788fd2cb9cbc93c0b5cdc1536b3a048..a0e8b3dc7c2ab54b9a84670611fc9914e11bec07 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f7fd591b6e1d96875730144f19f725c8678c7dc..adb57ef124d698aab07d2415413ddc0bf8807d83 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6b1c772677b672a323a9cc5671a68f4da151bf7..2996818bdc654f4081e14bf7758c95d7ab3c35a6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2021 by the deal.II authors
+// Copyright (C) 2008 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eebb50ce0f97fb3fb023b7c236236d9fa4311f8a..82c41f9e57831c7194216fac038c9dca0202feb9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2021 by the deal.II authors
+// Copyright (C) 2008 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 76b04896b4f68d447bcc4a8e30dd1b46e678508e..32313df42849f6ba3257c0c60e8c5e31ffedabe3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2022 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0eabcff1c528050dcef63629b2be56b836fa3405..951d68ce0794c4a6506a05a3d2f7dbd407b008ff 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 49b8a15279dc0d0bf0dc29458eda254e2515123b..7ca97ac7b6e67156ab0c0ca4aed5bf43697cc40d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2020 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 236e6a53965e5b7fd96bf9d47bbb148a001b8bd5..1cfc7aeb485dcc43fcc03f527c2ffab4808bc2db 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2020 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05c0c74688bb78885f283692be28e64ed8c7b3df..94dc56cfaa89690411a0bd8b584371229f861542 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2021 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96b361bfcc31bc218562947f3f7b37efbce74222..ad13fd03133a9e4c9b88f0a9cbc0e9edfc7278c0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2021 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 800d217b72f90764016ca061436c44bb6a52d1bd..d226943c3335f4429dac860babfa42f91af33f1c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2021 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 714eeff13b3bdf5dbb6b0ece3bde783f42c59261..df40e39b0d709609c0583c9ac726ef33d07ed708 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2022 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a4815868019640398b3ec170e592167a3e89d4ee..e630687b52d101bcb3af9be54bd66a7d956da686 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2022 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c75faa874ec48cc7eec895dd65f78c245776a642..1b3a13ea21ac6fcd332864568647e538f416b552 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2022 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8bb35257bcfdb7c0a12ab64135d7184e18fc6041..e0fd5e9af452a10b847289dea2afc5e887d2b58f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b17dc99edc5f3e16a1596c094a69a8b0ce371aad..414d9249363760adbeb85ce38f475ead1f0126a3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af4815087c5c773ffa2783a7e633c589a637a6f7..e94c393b910ee38b55d6c1c32532b0770ec4ba9c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2021 by the deal.II authors
+// Copyright (C) 2009 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b11deb7cbcc7330082ebfd99e630c011b572b662..3dcc7a19e0cb6e92ab5d62183e66943d4b4e1a4d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2ed646a6b5d0c3b4bc2e5c9f94ff7c6d199a9be..89d1125588edf258f9ddc67acbdfa3c5119f6ca4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b4e62443e3be3447f1c8d569964f568fa397800..34af80f236eeb5823c537298f9124a2800783b22 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d5a0bead530919ee5eeda1249f28d1a0dd515eef..eaa770f399b3d50f7789977aa89ecd366bc1a6c5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9f765ac3fb0aa814b60fae4dd4669975b78431c..3684cf651ade48a4903d2caa2224c65b089e31b2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 760fa386371f2fff479708b1e1adc31509c859d1..097787a32ff7a9eb200d47c773cae8bf5f33cda6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1034453e0ced7e6388087e3eb844fc4a591e66b6..6f7f1f7191f1593700da8a3bff7b96fb1407ce02 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e86cc1ef97a5cb87c12bbd639ba37629eb165fd1..5e23975134f38228dbad8b5117a42b7a5b8e45b5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2021 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 479898f4cd89010c5971d4586acacf15391911b3..d3491cf32a086a4e7ab5f8cbaafa109c63f9f3b9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2021 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e214319cb0b4d55058af95553beea75b81d1cc1b..35eaff4ada42a7b42c235217e82bb5f2fd2cc956 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2021 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2aca704e7c2ac0a65aa1b8a74676212abd233fc3..c1ed26065a3265ec5fd8354b4932756fade00314 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee8647e5443cdf02d0e895b150bda6ca5cb9c382..c9d05d791e7ca1aeeefd794981d43ac379933b7d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2021 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee8647e5443cdf02d0e895b150bda6ca5cb9c382..c9d05d791e7ca1aeeefd794981d43ac379933b7d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2021 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f368b626201a65cd2406a6e663e3fbb958f7866..0f67cb6f7a2c4498c53ff77cf9f3f72f3e0046fa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2021 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a21fa9209b1402b61fe94ce95962613954a9ab0..2366a2e799cacfb85a9c5e49748bab7f95e3d28f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2021 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9b84f0195fed979392f4d0187be79a7d3bcd53d..c7584aaa4433fdca64680a3a4df29db85168e016 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2021 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9dc5efc907ed50013e7a2281b6ef10260908ee6f..4535270254d1bf0d270d864c968c6a98562d0474 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2021 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9473c6e57be78dd5637633760ab3b152fe4c9ba1..0ef20e3e755de1fc0b199d635468f9c19306862d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2021 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66f78351071319d6c7924045ff81f295c3d19751..e6b18668b1cfaf81154871bb905c5d7b3e7bc873 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2021 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99afd752a786429aa6563257b61690e308aa22d5..394850ddd3040de50ea3a78f76c278d6a7f9eeb3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05e89b180ca640feb23e5110e8ff3edf9ffee4fe..2d07b3fe5119c61e80a1b1c4f13bac3dd0a665fb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3c3968f54ecc5aebee54f509a9f42c1bcad3d70..93c1967dcd21db5ee51ef5843332a978172a9031 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2021 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ff8645ba459b37a3a28f9e2b7559af46a94ccea..b368036e3518af5d18a31636880859169d28e8ad 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2024 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4caa8c6e5de314512aea8e7a0e933dbda2c3a4af..9d161cbf0e8f3e65700c0bb36cc1764a272da354 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2024 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 72ace08d45a54d2478303c0998a36b934166d0b0..9946849716b76c5f6a7673452b753dcf6863669d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ebd0523a079d979e2f137dad323c836a9519f44d..7b8e4f5718cdd88d5d8aec9fade15a4f3ba6cb09 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5eaa7065778b0450ab7678c86ed62c717b20cea8..f3a477fc7be13531df275d85539ad440acea5712 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ea5cb2c598c46e139d7cdf8ad909a4d4b1fa924..a4a2ea8cc3fda9d59503da08b42f51721791f6b7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa837b261afebc1be3792df923135b8a221d3fea..1fa50e547c2fa5bf6467dc3dd0fa8d0862a41f43 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f266bc26060ff566d63c57e899897068bc0295d..7c7dd6c888a9c69d5e3c2d6282cc2f52fef4a55e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc221c653c2cd70dce5f8570e86dc37be1eac90e..2345c4e27a70d37634ce7659124dad7c850ac0ba 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04b62bab543281ff0dc8b0ee8aab3caa14bfaa75..65d71473a8b252a819c3833dc56904854d63955a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a70c345cd2fbfdc5c8ba5ffe12c2c1498959e059..c92679b6381f8a95796e66d296ebe6df159479e6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ccee11fdf60612d724885d841cc1eb6150557cc1..9cbc5fe8080c4022ead2f72450a9d3600502cf36 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2022 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 29339f06e1928d52bfcee2c8e26fb36ebb47fcd4..dd8d9138bee3f27985495502dddddd667f292b7b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2020 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d982bccd3d741481b3ff347505886662e80aa737..2cee32961a1ce217e50a67a8948cd58ad4060a6a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92efe5f25e9b536179e8dab4cbcc4a0636dabb61..2341021ff223e5d20ed504be8172b903e1aac8e6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa5436041d3baff63dba863fbccd50485ddcfaa0..fc669de46d6ce3a405df85f4c714cbf0000e79b3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3970016d7cd2aadf8942f60eb2113b8ec26f0a49..265fb035ce09d8b66b760549a0501027a4523354 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16a8990fa094c3a8c0c852626b17c37b0053308d..96e281c5d74e9967d1cb740f05d3683a888cccfa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef418662369766ef22f2d30982b3e3a92f3d8051..c4c847884b06c68dcdad96e0f49f2b764f91932f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2020 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9174d5fecffa1f803f1aa08d875ea2a1413161f4..d4bda89b2742d6fd64e9861d234011666cf27ebf 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2020 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a831a230e3dd0a83e281cae580ef6019b30f1234..ddf90f958adfcc485f35beac3c85ea3787ff8b68 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50a1af9bb5de2fbbbdb3db57a7a6c738f57d6870..638c7546405eae10177e4ebf9b9efdd738d9a5bf 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7a007253beef99b5ad4855b07ac8fe1c4dabd74..71d40d05f3d51488699d83e7d24366a8a81eda11 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2005 - 2020 by the deal.II authors
+// Copyright (C) 2005 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04e3e5df0a411d3fada99c6b966e4e9e67ef3341..ad0209809d3fbe82e0253f5f53ba80be442f3db0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a33de5f9be433cbb858151c2c440e8a955534e61..da11b1f269e09b8a22d507cf344ff3f2713a70be 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97c228962f8a538859f394b9030ca54ebc9472ba..89280eb9e140cb9f6a8cb9b60c066f055b600fad 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91dc3fea33c1c5742fe46e8046254b9f461ceda6..d67cdfadedfeb757a8351d556ef1909f862d16e4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cceb9314fe6c8861dbc41693412036edada8b1cd..563edc56f25cf6724082cb1b889809408e9f9615 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37fd0c93893f6b8d83ac12771988a88e828544a9..9cfb533f1893c1f02fe40ea8b0e1abe3ac423ee8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3a8934442d9abc261bd90857b3a53c0cce5a587..b8a0b16cce79c0861bb876e8060647c3779f9159 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 24cfa5109c593ca923285fb4cd272dc95c13410c..9218b77581c5e40b104ed8cb99b3249cbced6640 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 516731f4fdae8b6ed03889a110a3eed9e28cbf2c..4c5e96760722e2e68d99e896d08da786e914ab40 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 83f6aa415642d63d8253bdbb255188ec08afabe1..a70d20096775ca4d78eaf840985a09718769215e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a98a30c0b07525938ab910d857eae1beab1d1719..7b33af18e261bfff677bea4d9c6014fed9a6dfa1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34dca9d73f8ef4e54a3ea3ec2966eb8ec3c4c216..b2d0410c8721d0d20b74080a78bd0b15eddbcd3d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 01b79dd87ccf688807d3be1a292ab5748ffbed50..7776ad1174abc6270456e9ac4b2eb329ba7991b3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 41c9e263e5887ed23476a237e767f9ed49610227..4caf5e67b771870477e7820a2967957f3b28f842 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa9fcdf3c47c59b6417be5387adbb0a1418b25a3..afc7bec123668522b52345cbbce6495259c78e06 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95a17a349f4e458d054f078bd2649e89dad866ad..2ca503d9fb435a28ca87bf62cca69de9d73b4537 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 843622f58c646a74d1c8b061106dcfb3ad6bd1b9..749eeb56ae0860695dddbf69b78c0761260aff8a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad1d32864004680f6422cf5e50b90b1d452fa220..89dce308467da7ccda2de81768f69b4999e3e0f4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0fdfc90b7eb27e2e2652b29008265ba11936f35a..037cbb68a0fbb0887b18d0f4c7c78c5b85bbeb97 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f0464e4fe282fab16e6f5328fc1ed201427deb5..a89b23de7ec74f2d1a99b71fdae7643f7822752d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0c27a19012429c98f4d809d7c046460f45a55ab9..1483f47844340dd51d15c46acff1978c3faf5f91 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 89a8aa7ea58cd1a4d0b0aae1e69c16160898b710..bc62aeffdd59eaa1db094570a87463bab89ed3ed 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17270584aace9b884263c8198855c95f43d317f6..841e1f334b2fb6929059425d75725bb973ab94ed 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 30076c4b45c7e60ed6209841b01285d5817a20f3..70b77d1dfaf756a934f37ff69d74022add02b01d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1999 - 2024 by the deal.II authors
+// Copyright (C) 1999 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c4b27e81195d827d1ddfb6f755c148c75412417..8319802f5b4d486705066c0da93e8c6c9770dfce 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e98ca333da1b41ee1144f22baa446b8e8b49b7a..8bf23d33f267c872b35ce5bb050f67acbb61dd54 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 370540b455da9d8d72b4e6912f41d0e34d89f8e7..8d099f2f91458fe0b34c6a4770e7939a890b8b98 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca821b91d46aa4d3734ff09432a130c0e30b6281..56301fac3e83c9be5fd3d5bb8b9795a634c14586 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6dad244d0200759d4c04dfcf49f575222f61c330..d630d4db945b885f2408bc6e2a3c96d067e8c567 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80ca3c5d6b9b1535ffa30680781c65b644107145..c53b4d5790a93d18bf468fa64aa1e8bc7d7ee691 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82261b46fbc1f1b4dd8d2fc0be6ce1dacc35be9f..5b5d0fd482c600ee908564b6b746bb22367d83a7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2020 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a4d6b0ac37126fa58246c702d00b0de36b43537..2cfddc1348287f61c891c8898b59ee612cca1724 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2020 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64e2a42c77c0bb5b4ba84701243bea070c1f0350..71bf174382c2fd684504a943da0f262476466709 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2023 by the deal.II authors
+// Copyright (C) 2002 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a62800f4f22041a81f386d86dcc4b8eb77cfcd11..56fa72409c4f31e2987b4b730e1b7daad9661811 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c325140c331994a34c21184b86cccbdd46cca74..357cec93b85e1cde1a871f8a321c8cbc1680a85d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2023 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9d650c0e101abef1982126afd475b1aa4d32e80..9c1441eeb96e43a3588d4b670a5a8db5c61b9a7f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2021 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0b2f1f4ffca5cc03ec06048fd86d562beae68e2..259bb7f8903dad8b4ab1f6651f004b2a00b27f5a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dde4b204928ef8496260983cefe80d31cd97969d..932085f182e14061f8d5227b5b1b90cf1294771f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa5db3ed51f0c020b6a8666194b04ddc69d8fb02..8140a5e9ebea2dfcfed5071d28bef300d49a1bdf 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc77b77448bd6b6b5b71f0110533ad465712b305..f5b72a6aabb76e42390d46d03a059db8f5b6e8bd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7925bcb69468070f1ee6ea180ea231dd85c04d13..796f70d053b62026d5539d3f860b4547be7269ba 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2022 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f701b56c166cb5d28e97357bade91efc0870d32..40ca9cdf0bd1b58c3545fc6ac941a76dfd4e18f4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2008 - 2020 by the deal.II authors
+// Copyright (C) 2008 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d786bdd202d76bbdd856b324e1410d8272ebdd6b..a9c0cf884e5946e85af2fa0be343f0bb6c74aaae 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2022 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b17dc02d3e9c3dce9e17536425a732552af6460..eede90ba070262cdeff99003ecd89ab045203828 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2022 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb6b812f72dfbb75b18b5b97a7a46fa0a2f50c77..7291d60787a394252828231138099c09f1f091c4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 53f74a0154b388087082261d6772f94991985411..0a58f5d3e537741bdf03ec01743c0d890a4ac2df 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94d72e5004871f8f1eac6a0c066dce6cc7744253..0f804ac53c880480efea79349104f46a73a7aabc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1510a8e0f2e24b00359d9d9630e5142fa7078ffd..e4babd6f7ebd2a6f3c5d88c79e450e6a90fbebf2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80d271fbb51de9dc84ed6e78ab5989e39748af7e..02beef5414a409bf79baacc4ab3e2577c612278f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 563e1743680ddc6b01c9888a0352ff4a3d4ddb0d..cb8d9e1fe5339af41fea85ce873c9405ad851edb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1622dc5f180720dce641259b2158cad27ec7f192..a63c98d3f5527330a298395690b07eb4b65f77f8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6d674022a7061e7bc92f7a775b28a160265b20c..f640bb5bd62a80399e90b815e247132b8aac0989 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2021 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45b5dc8ad9220052d2b4f4256f982e39bed1ddf7..403c15ef236354ebe2edfc4f26e9825ced910f0a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eda70dac538cdfdd8dedfe05d64741203db03229..8e5d974d8ab600b97c6c7fdc4278a7c550085ecd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f1009595552be5f1693993e252b8c93bb2460d5..71a9736c9e7a21a6c53cbab62cda38c97e29ce0a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2022 - 2024 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c237f110f3040fe625a4338a2dad718929c0a00f..119076c5520e73ab4a6229c4c7c9640567851c66 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 73da0f3ee15b1fec31e49895ddb668279cb93919..ed98b8b134920e0632603e96801e5265ce139094 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2020 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b10893f46621f80009eea4cb1ab80de3284ba6c2..706ec2349832444af8fa9c4c094961f00b8c1d62 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2021 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7926f5dd106e5a8ebda6ce54de428d6dc4f2749f..31af61a057b5a7b2951a0cdfbbd02dbc15acc11b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2021 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 226b08d6b3dd76b85c654e091efca3d63e84524b..70b8e2cf2bf1916d96e6f3a1bb249297bb60b45a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d14ecdc0d7e8aec727db88d4ceed342caff523be..96e520e671804c1bdd43e917cf23da7cfb7b6e6d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b1184380d587bc7a129970a579aa33b180d67d63..348fc84249bfd8cc0a5fabea4589eeefd3645419 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2021 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a4fbeb9bbb08d2fd198038775e1eebfa4871eb96..5a8cc3e7fb9bc684658539219a2b1c6db2b721d6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 72a81a13c3fb72ae33a105e1a256a6d662f12f7e..f2cfabe00684ad4aebd7527d2c8c5ff0c7f03782 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f2d7217c5381fe4ba317a0fda1a551909153430..06674bf27a029db97d36789d949b35f0c159164f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54fd25f0a398c9cac92cac691e5802d7416ecd40..f75484ad906e8088fdf13193bc2172c470eeb66d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47fb6cb94a9ae08ebbbb22967f1b9004e5e38d0e..c1df1e75a1571987cce0229613471ec58cf7f985 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2951e18f96cf8f1ad9f488775c5f4b347dd746b..619192f1a9653f63dc0a3504b5d71d27b246f0f6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd0f4a0b3a53cd6a95c0b68dffb991ddf547146c..70b7d27bff2074312f1309cc89ba9914f0e883ae 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab2dc3e06bf486a3dda2b73ce137a72a12f14636..1fd0b3fb29ddbfe2f3bd4970f29b92dff5d1148b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07f8fb2330f8ec3d5ccd4c862e4ebf00063fbaba..be1ef1b2ea67309fdd76f7d273817848a0321236 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 349d626290522e0ee60e369f7e286d9ea24b63a0..ae7ce77a1e813f9adfc4f8a59fb19fa0dee209fe 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd3214687869d60cefb931dd2f7c92db48215900..9fafc1950375f5c69744e2b1046a62014be93c1e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2020 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8d95823cb1a22c526192a1735062728e3f5b196..bb2e8adf31e40ee2b3f3dfe50c90f7672cbec927 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2020 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87e7491fa151722e25f373c03994a754ee80f0ab..739f78c36493ef49352bc73213d8ecf5f821ac97 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2020 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48636162d09dabe52f961f2786f3a2e630d1a0f7..fc37d2d9141d9098a59dc1bb8ebb17611a4146e7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2020 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55bdc4d2cb159a55e7127358c7569a39aa2c4908..a084cc8a84cc491782dfd11612a2075353ec0b4c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2020 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95d507b9c25c6f6ca23dad412d6dfb90112bfaf7..538d9ca0eec446be91ca7c2406ac0faf168b9418 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2020 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf439fd4499599a4caabc90587a6628a330071a8..472404c66b9ccf514080445b28d39980859a114d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8588888c60ec613195158a3507bbc445ecb6923..2c9d72741253fe19ba24e90aa9c03c23859cd6d0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a65652d3042d68b96fa2934b6e570036b9ff8ff3..1409485f6c883aa0a1ced5ca4cb3620700d737c5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2020 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0eb5f37d7daaef1cd6523e8f8ba4fb96c69b07c5..0505d6af532eb46e8c1377c838a28e225b423c6c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ad85c1909856477a0b09e1b1809ae6060f8e240..810b7d0c24bcef539bdea941752aab38dd05381a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98bee529f180eda9ab448ccd6f8453aa6a8938a1..e5ff235fc81470a4e7ac2f1898556089e6a56ad1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e96250eaf3ec9a29baf6b71076e12ac59226731f..909ac266b4936d9216b1bc3415a4f8a24fdab353 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 61c94e8c1a551bc01e2e93c72bf3bd64f4d510f8..70fe68288a511c48c0489646691cf1cc40ef620c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8dfa66e0e19713c47ca35b74239b81eb4d1bba3c..7d9dfc8171fb78bbcadb256c273a756bb87e4bbb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97fb5ad5de3980037d46c1e08fd14507a5968788..6b403c9753c5aa33ae4a94b791d8f5423d8e84b6 100644 (file)
@@ -1,7 +1,7 @@
 //------------------  matrix_vector_faces_common.h  ------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cedcb38262c8748b26d8d31644cd9615dcc5fc7..9956a58d689a74a301a81c8f1e1e6cf465577824 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37d90c0713dc9c733806f4f255db4d11edcecd83..e0fbe8b02102a06bd46ed10965df77d80384ba85 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc270a51492dc61c69ca7e8e4fc37228c7610d94..a3d75d8a3cef0c2affdf9bfb3b144268c57ca185 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f32ca508ae80b5d1fee3bdeccb95382306f631e1..037c751b4b3524fcda413330c86a2ad715d423f3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e8c0dcd98fe225e7b96e7cd93a167233a790daf..a54610c4f39f7e171338565d6ae8fb50f88bcd7f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a07382ff7e5441ddf5a13884a3ad1f5224c25b4f..20cf58f4f5ec1e4b33fcf27b3710b2317c5b23c7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8492e41c1d0895c95fface33791e1ddd9f336bbf..4dd4ce0547976a65c34199e6439aa1a2db1da33a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab02c1aa65eef56b696f54db893e7a6628c8f673..af70eb4cdda13c2dd55c75817953e2294895718b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b88acbc9bcef8021535fa36ee15bd7b212d94d5..96f38edc7eebc6d008870a2bede89b87e53e9239 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e1230c477d177f7ac63f35a17fda756f7f1a5cf..fd4cde27c89701b08675f47ab3c8da95e54ecac0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 295c6c053f35a467c78778fc36f9f11e9863d9e9..2dad47a70e6dc066f78d3479c1e4bf5057702b22 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 686ca18b4684f4ca85b8f46512c6b5717e8fdd02..4c9b6f32cbe6dda6237ae4b1969c76f10cfbce3a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fab22e0a0eb57cc2a8f2a8a94e9e54ab36983f77..4d9f9301d7697536360e6a75ccc79ee663881154 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b7bad6ba7673292f7972de65b13c4c92ffc13c52..5f65d29e9b458dbb33533cf02d7ce4c22382e13f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c3aec06321e823da046557ce3619ed1291ce673..9786bebfa78de762ca035f10c913d556decdd34c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b344eb08aa1a3fb1459ff965aed1b330bfb8d01..1dc9d4cc47c5a511434a71afce914c9cff057afe 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92ca3efc36be040496b2844aa8913f50b2261c25..74b0ca5b150f2ce4895a47128b8f0528c7bfd9bf 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9eda3655eaf8de5505f91108cf8ebab6ea8a96c3..6d21864016012abb7066f93088ec30c4600216e3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d97546493b291397e16d0ad88a68a90f3755d18a..ab2de8241aadadbf525a801616dfd00ac9f131f2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e77d84e3be056db3ccf82bb0d1fd3a5b9433f5b..9083ac6fe709f8af0ba060079ac43232e244c2f6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0fdc9ee4e8291af3303bbab91ed0143d95a13970..d3937c2c88b6e0f1b91d75848434c94cbb362afc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3206ef6d8efdbdbac6980afc02563b80cc5dd357..1be65c7e3a44252c04216c4091e8a40ef36705f5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 005d60caf7a0410212334d1c8f097e82e4c27b89..417a3b3dec5acd72f7f9832354effb4f5b3201c5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37225953fb6e9bbe1516d450e5da9164cf55601c..300fea07a0e6f8fa81df8c8d71202899908ddb1d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1994600d6f02e7a7b9dce2d56ee2c483b868f9f0..a9a600bbefcce2685a6c9a934f9d7ffc8e7d20f5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12cce4e4d0813c8edb357fca5b422d7c3366ad1f..f3173a677ed2c6920acb13821495763c36b1c2c8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04a64c4b8a76ac49284c8c32af0e54260be079cd..4148f7a7b93b75699bb12121a1c780f4fc26f068 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c5305d8d4c2196c3f9ecbbb97b5ac56176fa64cf..7889417cc327ef0fbdf817d15c9eea83e41678fc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2022 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8787bac2718f43e05679617f7106a57b2d602be8..1539f7bc568b37695154851eb8656f3d3f7e86d6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 082990719ff9f5b6dfcabe9e7110131214ca6fca..65b44279a4c66a2016e6f8d56fb06b3e179f6be2 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2018 - 2023 by the deal.II authors
+ * Copyright (C) 2018 - 2024 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 52f50f3b6093c2bfe2e0d55082586b83d96e8bcd..7be8d02185bc285c1325b74644b682d56e111ea9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b2fbc394d76474f08e08edcc15d636ee5f031d2e..a6a2222fc47e5ab4ad5a84adfcbbcc3898cdf4cb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d3dd6a39f8b5e50891bd0fffaa58fc0b5fe5d2e..a3830d86509a368111dd5273c80f8e8d61831b69 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a31f03a2308be4bd63132dfd2bdbb9878ed8f3a2..5240c901b7b0233b7e5fe63b36ea63e660c9e469 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 445c00b558301561419e5de290f437bd17abd937..c4f0611aaea551c118cbb4fa5088e23bbb46d42f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a76fc837b37bf4a429506773fbe5cffe1f1557ad..e1ef0c7cbce89a99643e3c30807ce916542be4ab 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 037bd421093ea58c32dbf9c2f5fb37de78d9b715..7c826e63a5e1f287c5a44724a098eb8fa64ebf29 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93b39787194835a5a38eb6901a090bc01ee8e508..d6f00875df89cba7b92aa145d043392cff00c304 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc2be5883346ecc6f6fd9ef9c85e0ed975c14322..428f2d650562d4b2d0c2699ccf3a30ea9e3e697e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ddc4443dd2f33f962ab81e6f0e42e26171569629..9ebf0afce93649e3c5be1e069fcbc50595fbb0db 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 36b0a6aa01ef5a587ec3ce395296ecf69e3c1e7a..8ffe02c7873e9d02e80da0f1e1ebe48d1e28bac8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8439cc4b478e45f6d29a2c39b015c82e1ac8031b..50cf2f271f5a7d35d30bf55ddd14665398f4bdca 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c1c9438fa513d98c62844bb7fcc9cbda35a89d4e..411bb783cb10aa4d05136f0ca3719c8b8fc0856a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0753eaf58d08482908ccb0757f0fc7ad9e81da0e..f262ba426bcefe1d5d7156cf756afbc86ebaf572 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2022 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74744fd0ecec8eb2da360841df49ed5c018643f2..a421d01368c33d6a49558a00f75f7eb53f2febd4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2022 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 680c17162d071f9a8f024383dfb847b2289624d1..60a14336e90163bbe959d55e34e729e6c0f2d3ec 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 748e9e457831a2c5f080490697d69e456ba6d96b..48b3ed1fb94b317fcb3b22aa1ddd3c5217d9875c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4379bf9f0d7d585afe9516797a6b0e9b4122898c..5d757158c51cc43d9e06896cc006fbdfb2d79584 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d06bce6397ae8e8302fdcf7f03e62031f516abab..d5a79fcfc6ab947ba3afd4ad1873c9355fe7e885 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 192ff3c8a77796ceedc020cd96140f02bcaa6899..7e0c808612efdbb40b2bfe2b2bc191450455b8c8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bac3f7d97c337bfe7499e64021973f089215c906..783e63fcf0d1dbbdd7258dc7e126c8dcd7594247 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5fa87c433f32e1b37420d3d39666bd61c5dcb1da..a4cd1bac237211a45bc81a67f68d3a9b4561dcb8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa211772c63bc38cb9eece9ed94dfbe8299a0da6..e032ac5377536836df4ed9d5b5fd7f9dc03fb457 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 67615a77da0f40fcac5d795a5ab0af562b3d1bec..b553a9f163eb07281bbb720cdb7139c41b781c6e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13369822ed133ff5ff6cbbb7cd30aeb55c391960..ceaecf546bc08d0d874cc07e67216a88a021b5af 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c851f1810cb83ce83661c13b8b95f1ac11a16d82..0fd0eb2eec23e14d13853fbbc634f3ac64489664 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fbaa96204d42116dcd624a04677902272d5dfdf7..1d049c7f3096cfa4973ec5f0ffb6fbd00b381e0a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 703e1772ccbb12c7cc86a03f98f8fb0f1a817f89..1ed9a3ee4d4295e7345a09ac02db1fa21b35ea7c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 538905f08cc0da9233da64f12baa91e35bbb6612..076e114b8ca9fe7855a349a4bf70b26285b8685c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca5cf6acff790d4765ffb720c763f913f8fbfe92..9f063a43fd2dd77b8dd6ef31940e5cb5031ed636 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f7dfcb026dfd633aa5d8d3ebb90058a06130c991..dd70893a10262ab4b4add1baff72cdca3542d47e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2022 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a725ce9a72c33dea70830433a4028117b1c5aa0f..721f0b31ddfcba25caaf9262e91d1b4a49421d69 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2022 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 02223e275968a321c4d42c7ab2f855f419f35150..6d6d30e6589770fb37272011d945c3cfdd75f320 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 228c0c0e236f543723956bdcaf056a91ebad05f3..f36671bf9244add7929492236c945c0743377e0e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb1024ba916b43854011d988d5b1f3da10e8914d..6f5d98d1e8db4c1403d1c240629a2346b49e2fd7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 190cbba94e028d4170ee03402a261b7713fa1b11..f66b9a69818f4a233d2e602d03f9720d814c377f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8cbc8939fa696ae251fa49180be1a76be93c3f20..9f4d6703507396dbf890c92020c3ddc93b56aeef 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77a0dc4069bab52b177450d6e1633659c51e5c00..5725bb91f805b092e7839ae099ca5d7c23a5c279 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 609fd303bf10e779241db06b29139fd1208fce88..2b0019cdfe54a523536c735a380fd207a98106a5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 448ab7f6c54f3d63a7cf4ff814f651101823ff3c..d145099bfbe9414ad7fecc2d4abf53b1dcd01150 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1271697863fd20df2fb2a53a8879ec8033e8928a..43cb4be77b289997866381f0c86b93b4605765eb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3223ad955cd0c46fb5f158035bcc8e35248bb5ea..7c6d199fe9960c87cefc58d87aefb128b708569b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 416857a4f899a499ce192693113a37c8a1ba02cb..ba36c3e56c18ee9ea005733057fbd496d4398876 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60b0650e8f2d7531a9c16239ff9b265127d9667c..f615cba31fb1ca84e7ca9263af0ae50ec726a1f3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f384739bd576b800bda241e20c343b72b025efb7..3c2ddb27373a8d413b46005cc6ac4462f69a7b9b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4b03cbb69c6ef7cc873adcdd05f2c3f679aa650..897c14322de46c670bcfefbf2063e03545df6d7c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 61bb8e401938bf787da1b1cf59f3793c63ecc7f5..3031147b010a635d1818be7b50910e18a0e745aa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2009 - 2023 by the deal.II authors
+// Copyright (C) 2009 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47395b395a039c03e6ff16731da5e903b1af394d..4fb480f9862f58d7d3c9254cc9c79466c5ddaeed 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98a74a2e95cf585663f6f39fa36a3518f6a94da7..7e8f8d06a3305384a601accda3aff0e796fdd9bf 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e56ec94a07ebe144d7b0b3e8dd832e4e6892df0..85996d21b9ad7a11927a0de607fb2516a9762068 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb273e2e8244d2db3edff238bf744af9f07120c9..ec9d55e70f2d76dae25a3cb669fbc8379931a292 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0bea74f3ceb2864338528052f5f6a876d4458539..5326c5044e464de5f928a8034e1cf8bb96f37bd3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a7df481c2284fe5318c3baeff8b5535db5aa17ba..521844b0668820a598ef61ebc6139fe848efa63d 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2015 - 2024 by the deal.II authors
+ * Copyright (C) 2015 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 0e898d756f2f0f7f9ddf03b40927ada9793db424..b103a9c2d71b45e836fd06634d600b47cb78a4a2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32076ff512da3a8009c1d081c77cf48c4e0737a3..0907926cc21175e67704a699552d9c9a05c571a8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 995fded45cfafca1ea894ffad8722e5ea5dc1590..a6beb92b93ff01a8b869d3ce4da489a92668e804 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 568be20c8a90c59e20c01123daff8f45cd77df3a..4bc676239a89165a2a65d9503ca816628de9172e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5af0a61a2e3d771bb0139ba370e831746798aca..849762b943e5c00fd4e51d36a5be633f3523d122 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ac9b94e081df7742f0e4cb62c8d03e03156883d..7fef9f96dc393a02d6672402e565f7464b85a4ed 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2019 - 2023 by the deal.II authors
+ * Copyright (C) 2019 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 7232d6bb89a2a0c20738dce969f98716d3ee26c4..6ec7b2bd099060b2ec80a077b0020d4066689214 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2011 - 2023 by the deal.II authors
+// Copyright (C) 2011 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37c2ffd2d8b8dbb7a3daa51f480eb0a5cb1629b2..fd00cc8774fba3b7c946b1e58acbab9f3bb8cc8c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2023 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e6ac6f04a9c2f814b3e3f4c4469c57ea01e5e0d..495c2a863ec98f41c521968fe2c27966d2be3d5d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec31643421822fa3eb241d8fdaf52f78e6089241..724b56fc3329b50c02a280de672b65cf1ca97c97 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2a3ba15c62afeed7a0db7b40f9b7c0a49d877dd..ef42ea8cc1a9e0241904c03df21930c247bd7cda 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7c60b4c72ddee84cce973e66de6c68fcf79b8757..190f34fd8a73cc0a2e877dacb0d0519ecbbfca83 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca9d9578081d5bf9431745f3f6888133bbe9d290..aac24ab6cc33d8145df0abb7e8c8f25cd2a3c3db 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbcad94f9bc9def143bfdd365fcf399c72e8744f..8080d0a4239dd652b50917a73f8bd78b8ce18189 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52e71b4f7a181d4786f8df035ddeccecd209187f..c9721ce2e1cb1dd214b37ae200313d98d0e4415b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e7c69d2af2604bea8ae618e5746a0a04924f655..540273d79d7ca9f727af43c96ac4a33fbe4fa9cb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0e9fd3550df53a68afa649adeee267e754dcce3..cbe105a7c92ead5840e869393b27cdec925aa367 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2018 - 2023 by the deal.II authors
+ * Copyright (C) 2018 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 580ed316b99134966b3931387e82de0301f7c3f5..0ef74d70dc6c59de3a4bc7fc50d8a3fe8af67d9d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba6088b4cbccddc975c9da8627414e396520087d..4d3c4540dbcc7a0de16364d9f411a35319b64bce 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1da956e15309d94fc7a681a91a8880a32916873c..e77ecfbcf6a8b705e26783a0a64bed5c598e748c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13b6bc1badfdeda8a36d99b53a864561716e78db..bef1f12ee1de0f572e4d99010c3b73e28f6f323b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2023 by the deal.II authors
+// Copyright (C) 2012 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 243c3fd2b062b35fd9981d71d5334bcdb13cb431..ad35125baaf0488ff20d9b7b1554ce0019e2428a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cdd0f6867c6285efd63f3eaa3fae2cce91be2d21..53afe910d0500eaa79a6d4e820d614a1931ad25d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fb96ee86b39706cf6489e2668e3b33e3ea529e61..70f54e8e2afec3b0a12f78fc882578d38e1489d7 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2019 - 2023 by the deal.II authors
+ * Copyright (C) 2019 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 60237476b5bde8eab19eae762ab0fb8f45c0c290..505771cda630e002ec0c896cc2b23f74bf3f96a6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e0165fbc5df0a6d6d0c5d4b6254a7021145afed0..950bb25f948b2051d3bfbbd851c27a2ec4bbe5d1 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fde1456211d17ffb88652f9ff8d9640e9e394607..9c0dc75d5f3b33b05c5963c637de1fc3acfe926f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7021a9849ad8730151904e85f22d5e6f8c4634e2..0ab5abb04c8a679c02d83d07065e444b0dad757b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3d493e8727ec1f6a722971bb0136ed4b23d62be..dbb6e7126a56c23014d41ab509f2f71272150b50 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d95bff8a8be1f7f3459391b59bec934c194083c7..d764cdb59b41ff14b28c3c9862ea1c5e67f47910 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2018 - 2023 by the deal.II authors
+// Copyright (C) 2018 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81b69bf9fcf0a9aac3caf5df9637dac36db02874..2d3432da81d1753647b3fd832d0cf872c9a36cd9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4dd31165df823bf5e380bec67a8e76ab6f46bafe..10e6ba46c154f00afb64ece9d5b8272d11e98166 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b404743a8eaa34c1b0f4c9d77e453437cf1362d..9fbff8713a8b13f50618a7573cbc58241f92f3e2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 89d726f8a3efc6592a767e09fe3ebf2485555a2f..b3d63db9f019b4133cbb497a15ddb3803365a46b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28c6ac78539d5256d9f891b64418bdee03391a75..c5c587d52632822760a929a07e3c2c5dad327838 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 649d9a9a77b3248c32504dadadafbc904071d66a..158fa98d311083b193a7839e913109b9b4b0bc39 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34f0be9e170a3c193dae2e044603f405257cb8d7..9e08249e0c07307dabf4cbc4571885a7c88a12a6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad050023c9bbd143be47b2eb4bdd2b2a1c6a097c..8dd340d275350145f9af7b082262c0f9f6157f61 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a94591c61270050cb487869812de4946e863b833..8f8da90b9c0d3e5d41bfc05349f9eadbbcfd2eb6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ec675649634c617252279a4bb84a883903ed11d..fffe3816bbf6d1dd7fafe06f3c43da034411fbba 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11ecfec517d1c9703d521145e5866cd85420be29..12432f18f46eb043dfddba6193a88b45d8b3578d 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2018 - 2023 by the deal.II authors
+ * Copyright (C) 2018 - 2024 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index bbf5a5385b98deaf0db90a5be9f8e2033c09409f..0224000798564043a5e80e67761aed72e7500b67 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2016 - 2023 by the deal.II authors
+ * Copyright (C) 2016 - 2024 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index a73eff676691fad851dc64d5544bdc4dbfdfcd87..68bbcbed032dcab32f574368407e621292b22e3b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 58b35bfdeb1ea1c3c7a6e58603f9a7f24d9d46a7..28681b84e44705ce6cf77322df058a5b706c23dc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d26288c650afa2ff813efe146b1f12d37dc91c2..49792104344fa0ebd66c62c74801a5a92b22fc40 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b29b52c64cc0e4cc319f67bd5f80350064e7e54..cbd370fffbea6f844c8fd836a35969c4a7456a16 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b8a9df270f42b165217276ea03263d7791883f2..e0afd474c27d3b6f81ed0d91d1e9ea524f5b12b9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2023 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b3d38eaae9b7de0ba51f9bce8f55bf2a003b42b..63f31b79cd6bd22e92b828d3c7624f0fd521228b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8a2c6ef2136f95cdf0db85d540b6754d59e2ed3e..ea85eb61de2b51145ad6378a19bca86cfbcd28c8 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f3beb221272da6c595031ffba1f3c64e9fe5b246..bdd80c5ae8517d6d136f3c5bbd3fe02510a2c68b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16730d0edfe5e0f7344707632561b757accdadd7..4b51806ecddbcdeacd3327fcada4d46781087387 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2023 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5420fbf24a50273915896971775eb87798c8912d..75434d5e0b44324175fc74a11d1c0f840a5dbaa0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6e38f366f4bb8b3142303cca433e1b009b116c9..7922e266932fd744315ef3d9de918e122e0a5bcd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e85c602ae0c4c994a8e13705e56a9b9237f560cb..76bae767c22ed3ff527140e4ba575f177b3e0b32 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 06c2b3d343aab08d7d23aadf71a6b948efe02606..36bf16870a38a816ea8514ac7c32e6f17c13aa36 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97802a03ec6fc5f6239f2acf662153d894d94157..478b8e135315364c4d1a03a48b7b22e288d092e5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d899174489b3e1665732b163400878d6ddadea01..b17c8087c283488da4694b299baeb56dc8d8486b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2001 - 2024 by the deal.II authors
+// Copyright (C) 2001 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 087d27d4a374118358bef1e350fae32141cbf15f..462444d646920c7c98d866d23abed13c5b077ae4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b19639d23317f9bb48668835fd8237eee21117c8..06dc39f2daab62e71bf41d435a6b9dc5cf88e576 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2024 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 501ab4a2ef891f7bee1bb11b7f6c522809c73b0f..912dea93d6bc013ae94c1fbcc4033eb1f32141b8 100644 (file)
@@ -2,7 +2,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 225fd714215c1dcc420ad361490dc21dfee46a05..7c42e12124382faeaaf9f2639e4c69fc293c2095 100644 (file)
@@ -2,7 +2,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a91ac2f3c95362c5dd82a72ec549e9616e2078a..250e70267e589bafacd587ec81476a8af933e111 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1234efa2c59a1d55bec9c380b9967f35cfd6e155..d6ab33953dd73d8cafd2ef8d83192aa5d8f1678c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 948e62376e0727d7bf3cdb812b5699fafcb01092..4d300c79cf182913b2438e7bbf8f712c69742440 100755 (executable)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2018 by the deal.II authors
+## Copyright (C) 2018 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 08e6c1f188e9bc6e2c876d9fb08a91ca3084188f..dacd6fe40922ff24b0fb776153adc0ae23dcc629 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e2f055af23ea21eb108de9e701d36af4c79cd77..d2a51dcabf259495ffe5a0190a3d2e660d84a584 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b93ad7463177bb043978b9194ae88e14227bac5..71a0d9b4dade155cc31b3166fa91c8a756c0ec80 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2002 - 2022 by the deal.II authors
+// Copyright (C) 2002 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2f2c5652c80a4e7208387241793fd527742f3fa..f0959eff6f16bf264aa9a0cff0ffd20aa06b6de5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d2d596b2fc4dcc4be04072f33c014940c61eb3d..0cdde70d326fce1482c5728a4fc7c76b91b68b26 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94db0ba2b7ec9cce926df89af519f6502a68927f..3d9fd47c63719b5e631a81f4bfcb107b7c97af3b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6784367b3ec5cd100f0467f90204f2ecdff3c902..60d72c51bb25e435ad19d13f44272893b8762bf3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0be35a155299a4d516e9558328a7b8477b745528..f2b524a27167045b4c7b5c44863d615ec28fd0e0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 767a1aba4e4899b374e5b5aeaf0065d68a8d060d..e664fe75e9a149743a48f7d8d081b2b12233e75b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2936345f7f58a4a21696613e72e77d350178b069..cfc6eaa873cf219427c145ce19d60bb87afb94cb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b0905cf98375f4262d8ea68824a9add5f0e3119..ae1df72ed4dc7487a9318144998aa9e1aec1ac4c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88470918a40bbf6f2cad715df32c0d7639e0153a..4df2d83550b81f5bd4c4096aaf2649728cd2213f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59ddc709782beb5f885fe17afcb036854a399f21..c0f59a5672c0c899c89cdaae4a7587b8814840b7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c73c3c54410816692fb4ecd56c3dcafe7c3ea5ea..518133a4b7bf2242e3b107e50e2b6477be1a6b42 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3045206c938ab86eb3a16c434e2546554d545e82..461f4e1dda3d0cdd3aff41e55184a5dd7abe98a5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b5333943583793f6eb25834818ccedf9f4c1b96..793994705833d9545938b59928cada8dff30ee19 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9ffe0664518865ba137a4c80b12b510b8647b74..8da4fbbfd69b1e337910e3e8ba9668f9af21f2b3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 070f7731b0faa14bfba6662626b10239033d7606..7b7a5cb5f3d60c017125e6eb712439a43c983dea 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2024 by the deal.II authors
+// Copyright (C) 2010 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 517875733a880b6e578a34ba223b33c27f3049b3..87258f32f9fe2336a7520c204fdceb08f74db57f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99007ae6e4f15182c97157c8665f7481df2c57e3..fcd296e9708e1a7b8564d775bae34565701e57eb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2022 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 267dc456150a1b6319b0ec1fd65a9535a900b590..dd8f1c871c3e41a740c96cc9bb41919cdfa720ea 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2010 - 2022 by the deal.II authors
+// Copyright (C) 2010 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 20b229090152638359ced9d89f6accf0dade3e9e..3fd189ed61514da5a4be1e0f8fc49664b8acee77 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2022 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9134353b97071bdc327b7042587d3804180f3296..c7a420469182357fceb044b5017cc80707db2a89 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ec7ab301356b1a6c4bd2bfa44727f385d5c84eb..99139818aab0e40c6f72f65d195c68547d0050a4 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b5947a2d65e259850b568285421bbecdb44a41b..5f507f6045143ef57b9827fef8d8f083eefc14eb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2021 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 491b2d6e1a3a1f04d2b2ae68616c4abcee648dd0..896417a35fa2639763be5bd3d0d6426621081972 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 743d67cb0213be73437e94610fecb3640d7d528e..6a77961a06b5d38ee1f41dce4a448dbca7fa5cf6 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2023 by the deal.II authors
+ * Copyright (C) 2023 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 2f1b3d52cad2c7d3ec4099741ae0a67ecaa21dba..3478a09cd62b890ed0721daf0e82cf48eb8ae31a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 445fdd96a6a2cb2a3359d95fa56d5628099e6005..d79b605f9fa74e244ca4b066864a47608eb49fee 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b160ee96ef98734a9307089d11722fa64a6ec1c5..f4dd71b5878d0814c8a291a651979b69e268dfaa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 - 2023 by the deal.II authors
+// Copyright (C) 2022 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77bc8235157186a0d5a484126add937d28912163..8b10dce835c6dbdc2c95619e72b0a4b4ee5c1d0d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2025 - 2025 by the deal.II authors
+// Copyright (C) 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b4252a3c2022069166911fc6b77649546009dc3..b98927fab899d35d4aadb902d26117adfc71f7b3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e463b2dfac9e0c717cbfe8647380595366a63919..34ba0cc3a26bad1b2fa2fc726b0cee40f4eb191e 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e598a7ca8f654a25a1cd65c2ef4331f65e0bcaa0..5a0a56e6b94eb0df0049732610f1db4eff236012 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b3f373692bbb4d51ecfe5f569b1ea418311da25..db4a9fe3c621a2bcc9a9c92bf81a887207705b8a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 69fa0d5f2af2e13c67f281aaa5bfc85438555b78..4f468c3925ae32c18c01beb7d4fec9060aa35543 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 469fcfdbc20cf234232dd8b6f48a6b7b118ff8b0..55388000f12f57ef72e98e4e94dbbfde07f65a76 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e34a5d2411a7f800a469ba39dc8ca280e5875f5a..9d6cdcbfa42a94b257aafea5c62ff03f35915b73 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 495f020308b0c9492033883b66e0305f9f47f6f9..e674e847138947f71a2328825daf082494980508 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 495f020308b0c9492033883b66e0305f9f47f6f9..e674e847138947f71a2328825daf082494980508 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b0887a07ba7d3e9fc7deec6a2414c815a0b9f23..fcbd0675bf2ce6bfbfde0026f81cf55e2acbd73d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9c410a0012fa0048b3ed0e99d2bbdffedb19fc5..5afc83dd64b8ff04443aa8542193f1e4000e7cae 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 854710e8473a01152cc8fa37f324f865954cfe88..0644b01782bf87dddc9b5da04dc3a078dd542479 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7fe72054bba2bd517e0684cd30541ccc61d87352..327988893ec8923239ef74655ea3cc0f5cf8e7dc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2022 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3edb5c80a9f1a8bab335700f161b0153e4181069..a96c18bb2acd74ce043dba5694a0e55957464e22 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2013 - 2023 by the deal.II authors
+ * Copyright (C) 2013 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 6fe0d620a8ab1cb57d9538dda8c45b22eb732559..da3e8f115640b548bd6d8cb855c7b1939afebefb 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2013 - 2023 by the deal.II authors
+ * Copyright (C) 2013 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 94baedd0c80ce88cb71516096bac223f9592578a..ac7119bb5cfe6c5153716a00d755cab2ece1d5a4 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2013 - 2023 by the deal.II authors
+ * Copyright (C) 2013 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 9db7505bc2181134e8797fc3fc15b93ff4de2184..803a82266a21012849e34775a0f9f23458fdf22a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c694e63e1054118094cd5dca8ca3ff3123e0f7e..8f03e85850ae68aaa3391f83cd44f0a579e8bedc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 768075887b7a35d00fe33f480fb2fd2332bbb4a4..0981d1e45bd835181ecbb9fec2c9b16d1ace1359 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8724fd7dcecfc3d5f62a26e5b9aa159b43ce0823..7c03d9d07b8dd1a571d6880ef2f5b126cfd6f2e0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6796217c439cb298f4ceea8b1e83ff5a5fdda0c..63ebe925252ee47f78f2a5af9c408ee6afe0e611 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5d11a892d50a089829186887c6ada3cd368f20ff..3eeecd7f03e35b3860aa4d6bde13a7f2d3b2a751 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2023 by the deal.II authors
+## Copyright (C) 2013 - 2024 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 27488344a3e3b12020d040fedc8974c8d247e03a..d7d6b269f9015450536c05185f772024779d4b65 100644 (file)
@@ -1,7 +1,7 @@
 ## ------------------------------------------------------------------------
 ##
 ## SPDX-License-Identifier: LGPL-2.1-or-later
-## Copyright (C) 2013 - 2023 by the deal.II authors
+## Copyright (C) 2013 - 2025 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 4daaed1193aab01572bada3948f3a19218e5bc49..d0a29cdba80a32c2411fef666a24b23ee1aee54d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2022 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f800cc6ceb6bcb8cd8fa11f969c09160f9d5d9fb..e4b884e8eb0b7e68ba8595b8e2e799faf730b9e6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2022 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85b382b8f82c0bfe303845518cca5dc0b9bae3c9..570bdaa830628cd3c46c76a649410e44198660ea 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7bb740680841418cac1e6af4f95fe2220ee7aec8..628bef7f41da69873331e60b674cd3cf0ee33f4b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14fc78599a305a2a2d8c24f52680e00c89c1ed01..348e80c449fb180aad1fc67cc10c84c9988bed8c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6436b475872ade872de2ee719488c98a8ac561a2..2c76a2b497761f7c76f157fe122ae2e8827e6d6f 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2020 - 2024 by the deal.II authors
+ * Copyright (C) 2020 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index e0ed9134dd6e9aa4cd2ff6196003bbb44bd3f710..f93fdb85690fd985c40573493e3d77c40114109b 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2020 - 2024 by the deal.II authors
+ * Copyright (C) 2020 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 5dc4fa961dcf91c9534eb4075bb37c71a11386af..889a931b97f882976f624bc9ff8d7ba5064ed1fa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6eac5e104772f2cbf2aeb869f6a5dca818e5a14f..cda389e3ddb811e462e669943573ebee22fc28dc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a6a8d65db4658731974687a0a1d17ee0c885eff..6964510bc3ccc39a2ca2a663f3739bb6e54a34bc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3704c6e5ef91a63f73a538a9b02637cd2e16c4f6..659520f9d48f4d5a3eadfd069a97bb8fdb0ef0b4 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2023 by the deal.II authors
+ * Copyright (C) 2023 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 59b7fdb146577ee73915cd289ed93d2afc550294..4248df04391c675f86d042f56466008ae03a4445 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2020 - 2024 by the deal.II authors
+ * Copyright (C) 2020 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index fdbd55341df0ab14d8345c0fc673e636322190c0..ca4706f369c03a0de9d10c6d0ddcd0b5b45f78e6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0bbd46120d939d7e3a246e43e5c0a4ecbd75d73..6bf5a7cad3bfc92eee298d91d3454e829d21e1a5 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33702b4fea7ff3542119beb38b663eb90bd48881..cc6182f90c64fac87e4092cfda2b1057674aec2b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2024 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba5223e5fece84510e885e4d9c15982e1e085ac5..a4c1c8cb392fcbb21e4e05f0dba6f337d4db2584 100644 (file)
@@ -1,7 +1,7 @@
 /* ------------------------------------------------------------------------
  *
  * SPDX-License-Identifier: LGPL-2.1-or-later
- * Copyright (C) 2021 - 2024 by the deal.II authors
+ * Copyright (C) 2021 - 2025 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 7f1fefd2d92378393c5f520c38d891edeaf32957..25caf3bbbcfe3a59053cc5e2fee09137390635d9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a115116ff155d32e7bfac1e3ceb32952d8c573f5..335d55112f6d21adb6d47796484c388bff306c92 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d972b927ad3cea98c41184decc93a7c8c4b94b1..125e722172c03c69f535a7adf91abf488403dd99 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2024 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5cc89451ca115c8010685544978da7e4b864f46b..edb4e41270e4e7a1638ec6c1a31d4f12efde0e52 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c6b2d1a3b43e204ae39675fa2afb210eb019547..05b582178e0e3fbfbc43bfdb673b291f261456ea 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 302a1195255a6b81548545b2d87aa4c3d9958e23..6b6c1ec1e57094f8df801db90ed8e1a6c8a5b9bb 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 137e269eaa32ff76b4a7eb15293795bfbb57a054..a1c236f415a50fd71730e6f486a3df5f7752b12a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 804db9f3efd9e72e3be13f39ffb013c106263826..49ffa2f063f46b081368814d1aebde36fa8cc520 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6eccd08f47b206ee3c4eaa04689c32f4288e12a..7935f4ecdb22f9cfcaadfaf718a5ea457badb76b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2bb19292b72826d6fe09b2602dfada7c41e3838f..9f44a778260624156189cadac00ca395c7979404 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4557567d040bd354c17cd18cc17db139df955ebf..cc6d8688a934d6ea268e60939bed64f06e2c1811 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2020 - 2023 by the deal.II authors
+// Copyright (C) 2020 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a2324ee887303f15fd2dd892a36d9f7d71bd585..b548bc5c3cb8ddf73347d67247d5b98b71c78e51 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79e4c1f3f452f3ec08558655da6bd904e94cc56a..feb316457126c14dcf353115f52856835e83c48d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6dfa9dee0093d3686b5dd41e1590bbce63b8ddb4..1cfe593f55dee30f97c879a8aa6e31583cc3eefa 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5dcca728ae526584cbff7073465f80c45b8e02b0..6a640a3bbfb65d5f9e14dce472911e1f63e45c30 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9ca2105547cb4d8067b5bc2586b255b6bbbab35d..9707c175aaccc5676d01cfe697d0ce61b825672b 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97e0afdae2b3bd92213de7720cf1ea29ab1fa390..65f6b8f2d552607a79881df9f56e3b504382be8a 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ddddea730176bdd6f83f91d857a79804bf92191..31a2d9d77d173125e9e4188b9be760e80fa138e3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2023 by the deal.II authors
+// Copyright (C) 2021 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f1c16df1674fcd872e14e1d1aa077be868ed125..5d230735ca0be9c96d1d692b33890606c7c1ddbe 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2021 - 2024 by the deal.II authors
+// Copyright (C) 2021 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cae021c05ae0376e3f3cf347ae1dbbd1d01ce9e5..2ea32fa2f63f8416ac4417bcd7a27377ab0f70e0 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 598329c73528db3d9cf0ad97a982409b50e1d723..de98c9b40578643db771ad8b4c21ff6fe8cb29bc 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2020 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d65975ec49fceddfbfdf8c32572f64abfdf853d4..7a93d0e9c835c35cc19bf89e16b9b4e4a498a0a7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2020 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f095497ff437879489933bce5b3986da46616218..b53f7cc0393395ba1db2678106121bfc389dddd9 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2019 - 2024 by the deal.II authors
+// Copyright (C) 2019 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3cf5b901b6c77e21f00bc09795b8c63a4b8167da..95f7a342216313f14a77d2bdad89b6e6eca61870 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2023 by the deal.II authors
+// Copyright (C) 2023 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b76b2948449cb9e755b8f7fe7ed4f7e7fbe44e0b..175a5851c2b7dd0151e24ebdc9e07edc75e49aa3 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b3135913a5b1b565325a7e88fbfdf93004ae3df..59ea7ddcf74be19e5716eb68fde003dd02506088 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2021 by the deal.II authors
+// Copyright (C) 1998 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f3d2c6d46b59edc66d7590b0cfbb5bf604d619c..7a80b1f1ae9f606a526c5c662b06ee4245cab396 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2020 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2f6e2e7918d2af3770e8b966e073fb8e510cdc7..ccd8f35e75c30834adc71db726e8114d18b243dd 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2021 by the deal.II authors
+// Copyright (C) 1998 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 116a1286808c44dae709c784bb4d0b1218bc0eb7..69ed224e922c59cbf7b8b59c0eb19fbe25d825d2 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 1998 - 2021 by the deal.II authors
+// Copyright (C) 1998 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 147ff4616ebe01fe0fa341593595b6d7cbb7134d..f2307dd0e0431c941310962e5b4b4a05016474ab 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa6ca4200df3fee3a0039cbeae8087951245c7a9..446a1e40276256b5403fdcfc25fc88f426442ef7 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2006 - 2024 by the deal.II authors
+// Copyright (C) 2006 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a35cd06ac09bf5b40608c6ca3efdc9eb23cca2d1..f0686b41e97d32f093fe0fb1625248801f403c61 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3efe8cd72f5b37648c3607795a1c9e4974f67b7..82f5fd8f7677b36606a0cbf407d3ccfcd4dc8323 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index efef714ca2897d3e22a8dc728f7ebbad3dd8f283..e340e091f9f32cbb66d949c01107f4b3e42af068 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2003 - 2023 by the deal.II authors
+// Copyright (C) 2003 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 717e469b1e3597dfc78b0d8f22f13c1fe810669a..7d4b9e23b4f92c6074de10dd245c3bf13df8a73c 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2023 by the deal.II authors
+// Copyright (C) 2013 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59a4c45eda46eccdc954ad47fbf623ae491909db..c74214dd8799b90170e0a31f3294e9666584f16f 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2015 - 2023 by the deal.II authors
+// Copyright (C) 2015 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98358e7831374fe716140ccde5f56e5480040956..095118061830e61d5581e6258b415873ccc6c942 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2016 - 2023 by the deal.II authors
+// Copyright (C) 2016 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 572869dcac6a2c4bb34bf117938b9641a491dbb5..4e8bbf84a0f309e24b35d022fa729080b04925ba 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2023 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a431be2c851c9ccfd42b3b329b90bfc721dbb9db..011c8d321fc60e7dd33d2fe92e0b364bea8aa677 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2004 - 2023 by the deal.II authors
+// Copyright (C) 2004 - 2024 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 183d0941071542b3d15b906075474e4717a14cca..d96ac3ffe40b35d25812b17831170ba8cd83f7be 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2022 by the deal.II authors
+// Copyright (C) 2022 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e64edd39485cb3ddfc4e01ce913bf8ad164777a..b85ee82aea3eb2e7e99764df62d3f85f7b0b27c6 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2013 - 2024 by the deal.II authors
+// Copyright (C) 2013 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0cf6b35dbf3057656aca34b7969084402b1e1f83..23c7306875444707e0e3355a97f44b5491ed640d 100644 (file)
@@ -1,7 +1,7 @@
 // ------------------------------------------------------------------------
 //
 // SPDX-License-Identifier: LGPL-2.1-or-later
-// Copyright (C) 2017 - 2024 by the deal.II authors
+// Copyright (C) 2017 - 2025 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //

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.