]> https://gitweb.dealii.org/ - dealii.git/commitdiff
update copyright years 10097/head
authorTimo Heister <timo.heister@gmail.com>
Fri, 8 May 2020 18:05:28 +0000 (14:05 -0400)
committerTimo Heister <timo.heister@gmail.com>
Fri, 8 May 2020 18:05:28 +0000 (14:05 -0400)
3390 files changed:
CMakeLists.txt
bundled/boost-1.70.0/libs/iostreams/src/CMakeLists.txt
bundled/boost-1.70.0/libs/serialization/src/CMakeLists.txt
bundled/boost-1.70.0/libs/system/src/CMakeLists.txt
bundled/boost-1.70.0/libs/thread/src/CMakeLists.txt
bundled/tbb-2018_U2/src/CMakeLists.txt
bundled/umfpack/UMFPACK/Source/CMakeLists.txt
cmake/checks/check_01_cpu_features.cmake
cmake/checks/check_01_cxx_features.cmake
cmake/checks/check_02_compiler_features.cmake
cmake/config/CMakeLists.txt
cmake/configure/configure_1_threads.cmake
cmake/configure/configure_2_trilinos.cmake
cmake/configure/configure_adolc.cmake
cmake/configure/configure_symengine.cmake
cmake/configure/configure_vectorization.cmake
cmake/macros/macro_deal_ii_add_test.cmake
cmake/macros/macro_deal_ii_pickup_tests.cmake
cmake/macros/macro_deal_ii_setup_target.cmake
cmake/modules/FindGINKGO.cmake
cmake/modules/FindTBB.cmake
cmake/setup_compiler_flags_gnu.cmake
cmake/setup_compiler_flags_intel.cmake
cmake/setup_write_config.cmake
contrib/python-bindings/CMakeLists.txt
contrib/python-bindings/include/cell_accessor_wrapper.h
contrib/python-bindings/include/manifold_wrapper.h
contrib/python-bindings/include/mapping_wrapper.h
contrib/python-bindings/include/point_wrapper.h
contrib/python-bindings/include/quadrature_wrapper.h
contrib/python-bindings/include/tria_accessor_wrapper.h
contrib/python-bindings/include/triangulation_wrapper.h
contrib/python-bindings/source/CMakeLists.txt
contrib/python-bindings/source/cell_accessor_wrapper.cc
contrib/python-bindings/source/export_cell_accessor.cc
contrib/python-bindings/source/export_manifold.cc
contrib/python-bindings/source/export_mapping.cc
contrib/python-bindings/source/export_point.cc
contrib/python-bindings/source/export_quadrature.cc
contrib/python-bindings/source/export_tria_accessor.cc
contrib/python-bindings/source/export_triangulation.cc
contrib/python-bindings/source/manifold_wrapper.cc
contrib/python-bindings/source/mapping_wrapper.cc
contrib/python-bindings/source/point_wrapper.cc
contrib/python-bindings/source/quadrature_wrapper.cc
contrib/python-bindings/source/tria_accessor_wrapper.cc
contrib/python-bindings/source/triangulation_wrapper.cc
contrib/python-bindings/source/wrappers.cc
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/quadrature_wrapper.py
contrib/python-bindings/tests/triangulation_wrapper.py
contrib/utilities/check_indentation.sh
contrib/utilities/count_lines.sh
contrib/utilities/indent
contrib/utilities/indent_common.sh
contrib/utilities/run_clang_tidy.sh
contrib/utilities/update-copyright
contrib/utilities/wrapcomments.py
doc/developers/cmake-internals.html
doc/developers/porting.html
doc/developers/testsuite.html
doc/doxygen/CMakeLists.txt
doc/doxygen/code-gallery/CMakeLists.txt
doc/doxygen/headers/automatic_and_symbolic_differentiation.h
doc/doxygen/headers/c++.h
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/fe.h
doc/doxygen/headers/fe_vs_mapping_vs_fevalues.h
doc/doxygen/headers/functions.h
doc/doxygen/headers/geodynamics.h
doc/doxygen/headers/glossary.h
doc/doxygen/headers/grid.h
doc/doxygen/headers/hp.h
doc/doxygen/headers/instantiations.h
doc/doxygen/headers/io.h
doc/doxygen/headers/iterators.h
doc/doxygen/headers/laoperators.h
doc/doxygen/headers/main.h
doc/doxygen/headers/manifold.h
doc/doxygen/headers/matrixfree.h
doc/doxygen/headers/mg.h
doc/doxygen/headers/multithreading.h
doc/doxygen/headers/petsc.h
doc/doxygen/headers/physics.h
doc/doxygen/headers/quadrature.h
doc/doxygen/headers/slepc.h
doc/doxygen/headers/trilinos.h
doc/doxygen/headers/update_flags.h
doc/doxygen/headers/vector_valued.h
doc/doxygen/scripts/filter
doc/doxygen/scripts/make_step.pl
doc/doxygen/scripts/program2doxygen
doc/doxygen/scripts/steps.pl
doc/doxygen/tutorial/CMakeLists.txt
doc/doxygen/tutorial/tutorial.h.in
doc/external-libs/opencascade.html
doc/external-libs/trilinos.html
doc/index.html
doc/news/CMakeLists.txt
doc/readme.html
doc/users/cmake_dealii.html
doc/users/cmake_user.html
doc/users/doxygen.html
doc/users/testsuite.html
examples/CMakeLists.txt
examples/step-10/step-10.cc
examples/step-11/step-11.cc
examples/step-12/step-12.cc
examples/step-12b/step-12b.cc
examples/step-13/step-13.cc
examples/step-14/step-14.cc
examples/step-15/step-15.cc
examples/step-16/step-16.cc
examples/step-16b/step-16b.cc
examples/step-18/step-18.cc
examples/step-2/step-2.cc
examples/step-20/step-20.cc
examples/step-21/step-21.cc
examples/step-22/step-22.cc
examples/step-23/step-23.cc
examples/step-24/step-24.cc
examples/step-25/step-25.cc
examples/step-26/step-26.cc
examples/step-27/step-27.cc
examples/step-28/step-28.cc
examples/step-29/step-29.cc
examples/step-3/step-3.cc
examples/step-30/step-30.cc
examples/step-31/step-31.cc
examples/step-32/step-32.cc
examples/step-33/step-33.cc
examples/step-34/step-34.cc
examples/step-35/step-35.cc
examples/step-37/step-37.cc
examples/step-38/step-38.cc
examples/step-39/step-39.cc
examples/step-4/step-4.cc
examples/step-40/step-40.cc
examples/step-42/step-42.cc
examples/step-43/step-43.cc
examples/step-45/step-45.cc
examples/step-46/step-46.cc
examples/step-47/step-47.cc
examples/step-48/step-48.cc
examples/step-49/step-49.cc
examples/step-5/step-5.cc
examples/step-50/step-50.cc
examples/step-51/step-51.cc
examples/step-52/step-52.cc
examples/step-54/step-54.cc
examples/step-55/step-55.cc
examples/step-56/step-56.cc
examples/step-57/step-57.cc
examples/step-58/step-58.cc
examples/step-59/step-59.cc
examples/step-6/step-6.cc
examples/step-60/step-60.cc
examples/step-61/step-61.cc
examples/step-62/step-62.cc
examples/step-63/step-63.cc
examples/step-65/step-65.cc
examples/step-7/step-7.cc
examples/step-8/step-8.cc
examples/step-9/step-9.cc
include/deal.II/algorithms/newton.h
include/deal.II/algorithms/newton.templates.h
include/deal.II/algorithms/operator.templates.h
include/deal.II/algorithms/theta_timestepping.h
include/deal.II/algorithms/theta_timestepping.templates.h
include/deal.II/algorithms/timestep_control.h
include/deal.II/base/aligned_vector.h
include/deal.II/base/array_view.h
include/deal.II/base/auto_derivative_function.h
include/deal.II/base/bounding_box.h
include/deal.II/base/complex_overloads.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/exceptions.h
include/deal.II/base/function.h
include/deal.II/base/function.templates.h
include/deal.II/base/function_parser.h
include/deal.II/base/function_time.h
include/deal.II/base/function_time.templates.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/incremental_function.h
include/deal.II/base/index_set.h
include/deal.II/base/job_identifier.h
include/deal.II/base/memory_consumption.h
include/deal.II/base/memory_space.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_compute_index_owner_internal.h
include/deal.II/base/mpi_consensus_algorithms.templates.h
include/deal.II/base/mpi_tags.h
include/deal.II/base/mutable_bind.h
include/deal.II/base/numbers.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/patterns.h
include/deal.II/base/point.h
include/deal.II/base/polynomial.h
include/deal.II/base/polynomial_space.h
include/deal.II/base/polynomials_abf.h
include/deal.II/base/polynomials_adini.h
include/deal.II/base/polynomials_bdm.h
include/deal.II/base/polynomials_bernardi_raugel.h
include/deal.II/base/polynomials_bernstein.h
include/deal.II/base/polynomials_integrated_legendre_sz.h
include/deal.II/base/polynomials_nedelec.h
include/deal.II/base/polynomials_piecewise.h
include/deal.II/base/polynomials_rannacher_turek.h
include/deal.II/base/polynomials_raviart_thomas.h
include/deal.II/base/polynomials_rt_bubbles.h
include/deal.II/base/process_grid.h
include/deal.II/base/qprojector.h
include/deal.II/base/quadrature_lib.h
include/deal.II/base/quadrature_selector.h
include/deal.II/base/scalar_polynomials_base.h
include/deal.II/base/symbolic_function.h
include/deal.II/base/symbolic_function.templates.h
include/deal.II/base/symmetric_tensor.h
include/deal.II/base/symmetric_tensor.templates.h
include/deal.II/base/table.h
include/deal.II/base/table_handler.h
include/deal.II/base/table_indices.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_parser.h
include/deal.II/base/tensor_product_polynomials.h
include/deal.II/base/tensor_product_polynomials_bubbles.h
include/deal.II/base/tensor_product_polynomials_const.h
include/deal.II/base/thread_local_storage.h
include/deal.II/base/thread_management.h
include/deal.II/base/time_stepping.templates.h
include/deal.II/base/timer.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/boost_adaptors/segment.h
include/deal.II/differentiation/sd.h
include/deal.II/distributed/cell_data_transfer.h
include/deal.II/distributed/cell_data_transfer.templates.h
include/deal.II/distributed/cell_weights.h
include/deal.II/distributed/fully_distributed_tria.h
include/deal.II/distributed/grid_refinement.h
include/deal.II/distributed/p4est_wrappers.h
include/deal.II/distributed/shared_tria.h
include/deal.II/distributed/tria.h
include/deal.II/distributed/tria_base.h
include/deal.II/dofs/block_info.h
include/deal.II/dofs/deprecated_function_map.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_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_bdm.h
include/deal.II/fe/fe_dg_vector.h
include/deal.II/fe/fe_dg_vector.templates.h
include/deal.II/fe/fe_dgp_nonparametric.h
include/deal.II/fe/fe_dgq.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_nedelec_sz.h
include/deal.II/fe/fe_nothing.h
include/deal.II/fe/fe_p1nc.h
include/deal.II/fe/fe_poly.h
include/deal.II/fe/fe_poly.templates.h
include/deal.II/fe/fe_poly_face.templates.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_rt_bubbles.h
include/deal.II/fe/fe_series.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/mapping_cartesian.h
include/deal.II/fe/mapping_fe_field.h
include/deal.II/fe/mapping_manifold.h
include/deal.II/fe/mapping_q.h
include/deal.II/fe/mapping_q_cache.h
include/deal.II/fe/mapping_q_generic.h
include/deal.II/gmsh/utilities.h
include/deal.II/grid/cell_id.h
include/deal.II/grid/composition_manifold.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_out.h
include/deal.II/grid/grid_refinement.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/manifold.h
include/deal.II/grid/manifold_lib.h
include/deal.II/grid/persistent_tria.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_selector.h
include/deal.II/grid/tria_levels.h
include/deal.II/grid/tria_object.h
include/deal.II/grid/tria_objects.h
include/deal.II/hp/dof_faces.h
include/deal.II/hp/dof_handler.h
include/deal.II/hp/dof_level.h
include/deal.II/hp/fe_collection.h
include/deal.II/hp/mapping_collection.h
include/deal.II/hp/q_collection.h
include/deal.II/hp/refinement.h
include/deal.II/integrators/grad_div.h
include/deal.II/integrators/l2.h
include/deal.II/integrators/maxwell.h
include/deal.II/lac/affine_constraints.templates.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_ez.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_sparsity_pattern.h
include/deal.II/lac/communication_pattern_base.h
include/deal.II/lac/constrained_linear_operator.h
include/deal.II/lac/cuda_precondition.h
include/deal.II/lac/cuda_vector.h
include/deal.II/lac/diagonal_matrix.h
include/deal.II/lac/dynamic_sparsity_pattern.h
include/deal.II/lac/eigen.h
include/deal.II/lac/exceptions.h
include/deal.II/lac/full_matrix.h
include/deal.II/lac/generic_linear_algebra.h
include/deal.II/lac/householder.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/la_vector.h
include/deal.II/lac/la_vector.templates.h
include/deal.II/lac/lapack_full_matrix.h
include/deal.II/lac/linear_operator.h
include/deal.II/lac/linear_operator_tools.h
include/deal.II/lac/matrix_block.h
include/deal.II/lac/matrix_iterator.h
include/deal.II/lac/parallel_block_vector.h
include/deal.II/lac/parpack_solver.h
include/deal.II/lac/petsc_block_sparse_matrix.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/petsc_precondition.h
include/deal.II/lac/petsc_solver.h
include/deal.II/lac/petsc_vector.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_block_base.h
include/deal.II/lac/precondition_selector.h
include/deal.II/lac/qr.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/slepc_solver.h
include/deal.II/lac/slepc_spectral_transformation.h
include/deal.II/lac/solver_control.h
include/deal.II/lac/solver_fire.h
include/deal.II/lac/solver_gmres.h
include/deal.II/lac/solver_idr.h
include/deal.II/lac/solver_relaxation.h
include/deal.II/lac/solver_selector.h
include/deal.II/lac/sparse_decomposition.templates.h
include/deal.II/lac/sparse_direct.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_mic.h
include/deal.II/lac/sparse_mic.templates.h
include/deal.II/lac/sparse_vanka.h
include/deal.II/lac/sparse_vanka.templates.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/sparsity_tools.h
include/deal.II/lac/tensor_product_matrix.h
include/deal.II/lac/tridiagonal_matrix.h
include/deal.II/lac/trilinos_block_sparse_matrix.h
include/deal.II/lac/trilinos_epetra_vector.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_sparsity_pattern.h
include/deal.II/lac/trilinos_tpetra_vector.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/utilities.h
include/deal.II/lac/vector.h
include/deal.II/lac/vector.templates.h
include/deal.II/lac/vector_memory.h
include/deal.II/lac/vector_memory.templates.h
include/deal.II/lac/vector_operations_internal.h
include/deal.II/lac/vector_space_vector.h
include/deal.II/matrix_free/cuda_fe_evaluation.h
include/deal.II/matrix_free/cuda_hanging_nodes_internal.h
include/deal.II/matrix_free/cuda_matrix_free.h
include/deal.II/matrix_free/cuda_matrix_free.templates.h
include/deal.II/matrix_free/dof_info.h
include/deal.II/matrix_free/dof_info.templates.h
include/deal.II/matrix_free/evaluation_kernels.h
include/deal.II/matrix_free/evaluation_selector.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/helper_functions.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/shape_info.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/matrix_free/task_info.h
include/deal.II/matrix_free/tensor_product_kernels.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/dof_info.templates.h
include/deal.II/meshworker/functional.h
include/deal.II/meshworker/integration_info.h
include/deal.II/meshworker/integration_info.templates.h
include/deal.II/meshworker/local_integrator.h
include/deal.II/meshworker/local_results.h
include/deal.II/meshworker/loop.h
include/deal.II/meshworker/mesh_loop.h
include/deal.II/meshworker/output.h
include/deal.II/meshworker/vector_selector.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_tools.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_block.templates.h
include/deal.II/multigrid/mg_transfer_component.h
include/deal.II/multigrid/mg_transfer_component.templates.h
include/deal.II/multigrid/mg_transfer_internal.h
include/deal.II/multigrid/mg_transfer_matrix_free.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/coupling.h
include/deal.II/numerics/cell_data_transfer.templates.h
include/deal.II/numerics/data_out.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_faces.h
include/deal.II/numerics/data_out_stack.h
include/deal.II/numerics/data_postprocessor.h
include/deal.II/numerics/derivative_approximation.h
include/deal.II/numerics/dof_output_operator.templates.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/fe_field_function.templates.h
include/deal.II/numerics/history.h
include/deal.II/numerics/matrix_creator.templates.h
include/deal.II/numerics/matrix_tools.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/vector_tools.h
include/deal.II/numerics/vector_tools.templates.h
include/deal.II/numerics/vector_tools_boundary.h
include/deal.II/numerics/vector_tools_boundary.templates.h
include/deal.II/numerics/vector_tools_common.h
include/deal.II/numerics/vector_tools_constraints.h
include/deal.II/numerics/vector_tools_constraints.templates.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_gradient.templates.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/manifold_lib.h
include/deal.II/opencascade/utilities.h
include/deal.II/optimization/line_minimization.h
include/deal.II/optimization/solver_bfgs.h
include/deal.II/particles/data_out.h
include/deal.II/particles/generators.h
include/deal.II/particles/particle.h
include/deal.II/particles/particle_handler.h
include/deal.II/particles/property_pool.h
include/deal.II/physics/notation.h
include/deal.II/sundials/arkode.h
include/deal.II/sundials/ida.h
include/deal.II/sundials/kinsol.h
source/base/CMakeLists.txt
source/base/bounding_box.cc
source/base/bounding_box.inst.in
source/base/data_out_base.cc
source/base/data_out_base.inst.in
source/base/discrete_time.cc
source/base/flow_function.cc
source/base/function_lib.cc
source/base/function_lib_cutoff.cc
source/base/function_parser.cc
source/base/geometry_info.cc
source/base/index_set.cc
source/base/logstream.cc
source/base/mpi.cc
source/base/mpi.inst.in
source/base/mpi_consensus_algorithms.cc
source/base/multithread_info.cc
source/base/parameter_acceptor.cc
source/base/parameter_handler.cc
source/base/parsed_convergence_table.cc
source/base/partitioner.cc
source/base/patterns.cc
source/base/polynomial.cc
source/base/polynomial_space.cc
source/base/polynomials_abf.cc
source/base/polynomials_adini.cc
source/base/polynomials_bdm.cc
source/base/polynomials_bernardi_raugel.cc
source/base/polynomials_nedelec.cc
source/base/polynomials_rannacher_turek.cc
source/base/polynomials_raviart_thomas.cc
source/base/polynomials_rt_bubbles.cc
source/base/process_grid.cc
source/base/quadrature.cc
source/base/quadrature_lib.cc
source/base/quadrature_selector.cc
source/base/symbolic_function.cc
source/base/symbolic_function.inst.in
source/base/symmetric_tensor.cc
source/base/symmetric_tensor.inst.in
source/base/table_handler.cc
source/base/tensor_function_parser.cc
source/base/tensor_function_parser.inst.in
source/base/tensor_product_polynomials_bubbles.cc
source/base/tensor_product_polynomials_const.cc
source/base/timer.cc
source/base/utilities.cc
source/base/vectorization.cc
source/differentiation/sd/CMakeLists.txt
source/distributed/CMakeLists.txt
source/distributed/cell_weights.cc
source/distributed/fully_distributed_tria.cc
source/distributed/fully_distributed_tria.inst.in
source/distributed/grid_refinement.cc
source/distributed/grid_refinement.inst.in
source/distributed/p4est_wrappers.cc
source/distributed/p4est_wrappers.inst.in
source/distributed/shared_tria.cc
source/distributed/solution_transfer.cc
source/distributed/tria.cc
source/distributed/tria_base.cc
source/distributed/tria_base.inst.in
source/dofs/block_info.cc
source/dofs/block_info.inst.in
source/dofs/dof_accessor_get.cc
source/dofs/dof_accessor_set.cc
source/dofs/dof_handler.cc
source/dofs/dof_handler.inst.in
source/dofs/dof_handler_policy.cc
source/dofs/dof_renumbering.cc
source/dofs/dof_tools.cc
source/dofs/dof_tools.inst.in
source/dofs/dof_tools_constraints.cc
source/dofs/dof_tools_constraints.inst.in
source/dofs/dof_tools_sparsity.cc
source/dofs/dof_tools_sparsity.inst.in
source/dofs/number_cache.cc
source/fe/CMakeLists.txt
source/fe/fe.cc
source/fe/fe_abf.cc
source/fe/fe_bdm.cc
source/fe/fe_bernardi_raugel.cc
source/fe/fe_bernstein.cc
source/fe/fe_dg_vector.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_nedelec.cc
source/fe/fe_nedelec_sz.cc
source/fe/fe_poly.cc
source/fe/fe_poly_tensor.cc
source/fe/fe_poly_tensor.inst.in
source/fe/fe_q_base.cc
source/fe/fe_q_bubbles.cc
source/fe/fe_q_hierarchical.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_system.cc
source/fe/fe_tools.cc
source/fe/fe_tools.inst.in
source/fe/fe_trace.cc
source/fe/fe_values.cc
source/fe/mapping.cc
source/fe/mapping_fe_field.cc
source/fe/mapping_manifold.cc
source/fe/mapping_q1_eulerian.cc
source/fe/mapping_q_eulerian.cc
source/fe/mapping_q_generic.cc
source/grid/CMakeLists.txt
source/grid/grid_generator.cc
source/grid/grid_generator.inst.in
source/grid/grid_generator_from_name.cc
source/grid/grid_in.cc
source/grid/grid_out.cc
source/grid/grid_out.inst.in
source/grid/grid_refinement.cc
source/grid/grid_refinement.inst.in
source/grid/grid_reordering.cc
source/grid/grid_tools.cc
source/grid/grid_tools.inst.in
source/grid/grid_tools_cache.cc
source/grid/grid_tools_dof_handlers.cc
source/grid/manifold.cc
source/grid/manifold_lib.cc
source/grid/persistent_tria.cc
source/grid/tria.cc
source/grid/tria_accessor.cc
source/grid/tria_description.cc
source/grid/tria_description.inst.in
source/grid/tria_objects.cc
source/hp/CMakeLists.txt
source/hp/dof_faces.cc
source/hp/dof_handler.cc
source/hp/dof_handler.inst.in
source/hp/fe_collection.cc
source/hp/fe_values.inst.in
source/hp/refinement.cc
source/lac/CMakeLists.txt
source/lac/affine_constraints.inst.in
source/lac/block_sparsity_pattern.cc
source/lac/block_vector.cc
source/lac/chunk_sparsity_pattern.cc
source/lac/dynamic_sparsity_pattern.cc
source/lac/full_matrix.cc
source/lac/la_parallel_vector.inst.in
source/lac/lapack_full_matrix.cc
source/lac/petsc_matrix_base.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/read_write_vector.cc
source/lac/slepc_solver.cc
source/lac/slepc_spectral_transformation.cc
source/lac/sparse_direct.cc
source/lac/sparsity_pattern.cc
source/lac/sparsity_tools.cc
source/lac/tridiagonal_matrix.cc
source/lac/trilinos_block_sparse_matrix.cc
source/lac/trilinos_precondition.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_sparse_matrix.inst.in
source/lac/trilinos_sparsity_pattern.cc
source/lac/trilinos_vector.cc
source/lac/vector.cc
source/matrix_free/CMakeLists.txt
source/matrix_free/mapping_info.cc
source/matrix_free/mapping_info.inst.in
source/matrix_free/matrix_free.cc
source/matrix_free/matrix_free.inst.in
source/matrix_free/task_info.cc
source/meshworker/scratch_data.cc
source/multigrid/mg_level_global_transfer.cc
source/multigrid/mg_tools.cc
source/multigrid/mg_tools.inst.in
source/multigrid/mg_transfer_block.cc
source/multigrid/mg_transfer_block.inst.in
source/multigrid/mg_transfer_component.cc
source/multigrid/mg_transfer_component.inst.in
source/multigrid/mg_transfer_internal.cc
source/multigrid/mg_transfer_internal.inst.in
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/coupling.inst.in
source/numerics/CMakeLists.txt
source/numerics/data_out.cc
source/numerics/data_out_dof_data.inst.in
source/numerics/data_out_faces.cc
source/numerics/data_out_rotation.cc
source/numerics/derivative_approximation.cc
source/numerics/error_estimator_1d.cc
source/numerics/histogram.cc
source/numerics/point_value_history.cc
source/numerics/solution_transfer.cc
source/numerics/time_dependent.cc
source/numerics/vector_tools_boundary.cc
source/numerics/vector_tools_boundary.inst.in
source/numerics/vector_tools_constraints.cc
source/numerics/vector_tools_integrate_difference.cc
source/numerics/vector_tools_integrate_difference.inst.in
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_project_qpmf.inst.in
source/numerics/vector_tools_rhs.cc
source/opencascade/utilities.cc
source/particles/CMakeLists.txt
source/particles/data_out.cc
source/particles/generators.cc
source/particles/generators.inst.in
source/particles/particle.cc
source/particles/particle_handler.cc
source/sundials/arkode.cc
source/sundials/ida.cc
source/sundials/kinsol.cc
tests/CMakeLists.txt
tests/ad_common_tests/helper_scalar_coupled_2_components_01.h
tests/ad_common_tests/helper_scalar_coupled_2_components_02.h
tests/ad_common_tests/helper_scalar_coupled_2_components_03.h
tests/ad_common_tests/helper_scalar_coupled_2_components_04.h
tests/ad_common_tests/helper_scalar_coupled_2_components_05.h
tests/ad_common_tests/helper_scalar_coupled_2_components_06.h
tests/ad_common_tests/helper_scalar_coupled_2_components_07.h
tests/ad_common_tests/helper_scalar_coupled_2_components_08.h
tests/ad_common_tests/helper_scalar_coupled_3_components_01.h
tests/ad_common_tests/helper_scalar_coupled_3_components_01_tapeless_only.h
tests/ad_common_tests/helper_scalar_coupled_4_components_01.h
tests/ad_common_tests/helper_scalar_single_component_01.h
tests/ad_common_tests/helper_scalar_single_component_02.h
tests/ad_common_tests/helper_scalar_single_component_03.h
tests/ad_common_tests/helper_scalar_single_component_04.h
tests/ad_common_tests/helper_vector_1_indep_1_dep_vars_01.h
tests/ad_common_tests/helper_vector_1_indep_2_dep_vars_01.h
tests/ad_common_tests/helper_vector_2_indep_1_dep_vars_01.h
tests/ad_common_tests/helper_vector_2_indep_2_dep_vars_01.h
tests/ad_common_tests/physics_functions_01.h
tests/ad_common_tests/physics_functions_02.h
tests/ad_common_tests/physics_functions_03.h
tests/ad_common_tests/step-44-helper_res_lin_01.h
tests/ad_common_tests/step-44-helper_scalar_01.h
tests/ad_common_tests/step-44-helper_var_form_01.h
tests/ad_common_tests/step-44-helper_vector_01.h
tests/ad_common_tests/symmetric_tensor_functions_01.h
tests/ad_common_tests/symmetric_tensor_functions_02.h
tests/ad_common_tests/symmetric_tensor_functions_03.h
tests/ad_common_tests/symmetric_tensor_functions_04.h
tests/ad_common_tests/tensor_functions_01.h
tests/ad_common_tests/tensor_functions_02.h
tests/adolc/ad_number_traits_01.cc
tests/adolc/ad_number_traits_02a.cc
tests/adolc/ad_number_traits_02b.cc
tests/adolc/ad_number_traits_03.cc
tests/adolc/helper_retaping_01.cc
tests/adolc/helper_retaping_02.cc
tests/adolc/helper_retaping_03.cc
tests/adolc/helper_scalar_coupled_2_components_01_1.cc
tests/adolc/helper_scalar_coupled_2_components_01_2.cc
tests/adolc/helper_scalar_coupled_2_components_02_1.cc
tests/adolc/helper_scalar_coupled_2_components_02_2.cc
tests/adolc/helper_scalar_coupled_2_components_03_1.cc
tests/adolc/helper_scalar_coupled_2_components_03_2.cc
tests/adolc/helper_scalar_coupled_2_components_04_1.cc
tests/adolc/helper_scalar_coupled_2_components_04_2.cc
tests/adolc/helper_scalar_coupled_2_components_05_1.cc
tests/adolc/helper_scalar_coupled_2_components_05_2.cc
tests/adolc/helper_scalar_coupled_2_components_06_1.cc
tests/adolc/helper_scalar_coupled_2_components_06_2.cc
tests/adolc/helper_scalar_coupled_2_components_07_1.cc
tests/adolc/helper_scalar_coupled_2_components_07_2.cc
tests/adolc/helper_scalar_coupled_2_components_08_1.cc
tests/adolc/helper_scalar_coupled_2_components_08_2.cc
tests/adolc/helper_scalar_coupled_3_components_01_1.cc
tests/adolc/helper_scalar_coupled_3_components_01_2.cc
tests/adolc/helper_scalar_coupled_3_components_01_tapeless_only_2.cc
tests/adolc/helper_scalar_coupled_4_components_01_1.cc
tests/adolc/helper_scalar_coupled_4_components_01_2.cc
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/adolc/helper_scalar_single_component_01_1.cc
tests/adolc/helper_scalar_single_component_01_2.cc
tests/adolc/helper_scalar_single_component_02_1.cc
tests/adolc/helper_scalar_single_component_02_2.cc
tests/adolc/helper_scalar_single_component_03_1.cc
tests/adolc/helper_scalar_single_component_03_2.cc
tests/adolc/helper_scalar_single_component_04_1.cc
tests/adolc/helper_scalar_single_component_04_2.cc
tests/adolc/helper_tape_index_01.cc
tests/adolc/helper_vector_1_indep_1_dep_vars_01_1.cc
tests/adolc/helper_vector_1_indep_1_dep_vars_01_2.cc
tests/adolc/helper_vector_1_indep_2_dep_vars_01_1.cc
tests/adolc/helper_vector_1_indep_2_dep_vars_01_2.cc
tests/adolc/helper_vector_2_indep_1_dep_vars_01_1.cc
tests/adolc/helper_vector_2_indep_1_dep_vars_01_2.cc
tests/adolc/helper_vector_2_indep_2_dep_vars_01_1.cc
tests/adolc/helper_vector_2_indep_2_dep_vars_01_2.cc
tests/adolc/physics_functions_01_1.cc
tests/adolc/physics_functions_01_2.cc
tests/adolc/physics_functions_02_1.cc
tests/adolc/physics_functions_02_2.cc
tests/adolc/physics_functions_03_1.cc
tests/adolc/physics_functions_03_2.cc
tests/adolc/step-44-helper_res_lin_01_1.cc
tests/adolc/step-44-helper_res_lin_01_2.cc
tests/adolc/step-44-helper_scalar_01_1.cc
tests/adolc/step-44-helper_var_form_01_1.cc
tests/adolc/step-44-helper_vector_01_1.cc
tests/adolc/step-44-helper_vector_01_2.cc
tests/adolc/step-44.cc
tests/adolc/symmetric_tensor_functions_01_1.cc
tests/adolc/symmetric_tensor_functions_01_2.cc
tests/adolc/symmetric_tensor_functions_02_1.cc
tests/adolc/symmetric_tensor_functions_02_2.cc
tests/adolc/symmetric_tensor_functions_03_1.cc
tests/adolc/symmetric_tensor_functions_03_2.cc
tests/adolc/symmetric_tensor_functions_04_1.cc
tests/adolc/symmetric_tensor_functions_04_2.cc
tests/adolc/tensor_functions_01_1.cc
tests/adolc/tensor_functions_01_2.cc
tests/adolc/tensor_functions_02_1.cc
tests/adolc/tensor_functions_02_2.cc
tests/adolc/tensor_ops_01.cc
tests/adolc/tensor_ops_02.cc
tests/algorithms/newton_01.cc
tests/algorithms/newton_02.cc
tests/algorithms/theta_01.cc
tests/aniso/anisotropic_crash.cc
tests/aniso/mesh_3d_21.cc
tests/aniso/up_and_down.cc
tests/arpack/arpack_advection_diffusion.cc
tests/arpack/parpack_advection_diffusion_trilinos.cc
tests/arpack/step-36_ar.cc
tests/arpack/step-36_ar_shift.cc
tests/arpack/step-36_ar_with_iterations.cc
tests/arpack/step-36_parpack_mf.cc
tests/arpack/step-36_parpack_mf_02.cc
tests/arpack/step-36_parpack_mf_03.cc
tests/arpack/step-36_parpack_trilinos.cc
tests/base/anisotropic_1.cc
tests/base/bounding_box_5.cc
tests/base/bounding_box_6.cc
tests/base/cell_data_storage_01.cc
tests/base/cell_data_storage_02.cc
tests/base/convergence_table_05.cc
tests/base/coordinate_to_one_dim_higher.cc
tests/base/derivative_forms_01.cc
tests/base/discrete_time_1.cc
tests/base/full_tensor_06.cc
tests/base/function_cutoff_01.cc
tests/base/function_cutoff_02.cc
tests/base/function_parser_05.cc
tests/base/function_parser_09.cc
tests/base/function_parser_10.cc
tests/base/functions_01.cc
tests/base/functions_04.cc
tests/base/functions_11_gradient.cc
tests/base/functions_constant_function_00.cc
tests/base/functions_incremental_01.cc
tests/base/functions_incremental_02.cc
tests/base/functions_singularity.cc
tests/base/geometric_utilities_01.cc
tests/base/geometry_info_1.cc
tests/base/geometry_info_2.cc
tests/base/geometry_info_3.cc
tests/base/geometry_info_4.cc
tests/base/geometry_info_5.cc
tests/base/geometry_info_6.cc
tests/base/geometry_info_7.cc
tests/base/geometry_info_8.cc
tests/base/geometry_info_9.cc
tests/base/mpi_noncontiguous_partitioner_01.cc
tests/base/mpi_noncontiguous_partitioner_02.cc
tests/base/mpi_noncontiguous_partitioner_03.cc
tests/base/parsed_convergence_table_01.cc
tests/base/parsed_convergence_table_03.cc
tests/base/parsed_convergence_table_04.cc
tests/base/parsed_convergence_table_05.cc
tests/base/parsed_convergence_table_06.cc
tests/base/point_03.cc
tests/base/point_04.cc
tests/base/polynomial_minus_equals.cc
tests/base/polynomial_test.cc
tests/base/polynomials_adini_01.cc
tests/base/polynomials_bdm_01.cc
tests/base/polynomials_bdm_02.cc
tests/base/polynomials_br.cc
tests/base/polynomials_rt.cc
tests/base/polynomials_rt_bubbles.cc
tests/base/polynomials_tensor.cc
tests/base/qprojector.cc
tests/base/quadrature_chebyshev.cc
tests/base/quadrature_point_data.cc
tests/base/quadrature_point_data_02.cc
tests/base/quadrature_point_data_03.cc
tests/base/quadrature_point_data_04.cc
tests/base/quadrature_selector.cc
tests/base/quadrature_simplex_01.cc
tests/base/quadrature_simplex_02.cc
tests/base/quadrature_simplex_03.cc
tests/base/quadrature_simplex_04.cc
tests/base/quadrature_simplex_05.cc
tests/base/simplex.h
tests/base/stdcxx17_apply.cc
tests/base/symbolic_function_01.cc
tests/base/symbolic_function_02.cc
tests/base/symbolic_function_03.cc
tests/base/symbolic_function_04.cc
tests/base/task_group_size.cc
tests/base/tensor_function_parser_01.cc
tests/base/tensor_function_parser_02.cc
tests/base/tensor_function_parser_03.cc
tests/base/tensor_function_parser_04.cc
tests/base/timer.cc
tests/base/timer_03.cc
tests/base/timer_05.cc
tests/base/timer_07.cc
tests/base/transpose_table_iterators_1.cc
tests/base/utilities_01.cc
tests/base/utilities_02b.cc
tests/base/utilities_04.cc
tests/base/utilities_05.cc
tests/base/utilities_06.cc
tests/base/utilities_07.cc
tests/base/utilities_21.cc
tests/base/utilities_22.cc
tests/base/utilities_pack_unpack_05.cc
tests/base/utilities_pack_unpack_06.cc
tests/base/utilities_pack_unpack_07.cc
tests/base/utilities_trim.cc
tests/base/vectorization_01.cc
tests/base/vectorization_02.cc
tests/base/vectorization_03.cc
tests/base/vectorization_04.cc
tests/base/vectorization_05.cc
tests/base/vectorization_06.cc
tests/base/vectorization_09.cc
tests/base/vectorization_10.cc
tests/base/vectorization_11.cc
tests/base/vectorization_12.cc
tests/base/vectorization_13.cc
tests/base/vectorization_14.cc
tests/base/vectorization_15.cc
tests/base/vectorization_iterator_02.cc
tests/bits/anna_3.cc
tests/bits/anna_6.cc
tests/bits/block_sparse_matrix_1.cc
tests/bits/christian_1.cc
tests/bits/christian_2.cc
tests/bits/coarsening_3d.cc
tests/bits/cone_03.cc
tests/bits/cone_04.cc
tests/bits/count_dofs_per_block_01.cc
tests/bits/count_dofs_per_block_02.cc
tests/bits/count_dofs_per_component_hp_01.cc
tests/bits/count_dofs_per_component_hp_02.cc
tests/bits/cylinder_01.cc
tests/bits/cylinder_02.cc
tests/bits/cylinder_03.cc
tests/bits/cylinder_04.cc
tests/bits/deal_solver_04.cc
tests/bits/deal_solver_05.cc
tests/bits/distorted_cells_01.cc
tests/bits/distorted_cells_06.cc
tests/bits/distorted_cells_07.cc
tests/bits/distorted_mapped_cells_01.cc
tests/bits/error_estimator_01.cc
tests/bits/error_estimator_02.cc
tests/bits/face_interpolation.cc
tests/bits/face_orientation_crash.cc
tests/bits/faceq_face_interpolation.cc
tests/bits/faceq_subface_interpolation.cc
tests/bits/fe_field_function_04_vector.cc
tests/bits/fe_tools_01a.cc
tests/bits/fe_tools_01b.cc
tests/bits/fe_tools_01c.cc
tests/bits/fe_tools_02.cc
tests/bits/fe_tools_03.cc
tests/bits/fe_tools_04.cc
tests/bits/fe_tools_04_overwrite.cc
tests/bits/fe_tools_05.cc
tests/bits/fe_tools_06.cc
tests/bits/fe_tools_06b.cc
tests/bits/fe_tools_06c.cc
tests/bits/fe_tools_06d.cc
tests/bits/fe_tools_07.cc
tests/bits/fe_tools_08.cc
tests/bits/fe_tools_09.cc
tests/bits/fe_tools_10.cc
tests/bits/fe_tools_11.cc
tests/bits/fe_tools_12.cc
tests/bits/fe_tools_14.cc
tests/bits/fe_tools_cpfqpm_01.cc
tests/bits/fe_tools_cpfqpm_02.cc
tests/bits/fe_tools_cpfqpm_03.cc
tests/bits/fe_tools_cpfqpm_04.cc
tests/bits/fe_tools_cpfqpm_05.cc
tests/bits/find_cell_1.cc
tests/bits/find_cell_10.cc
tests/bits/find_cell_10a.cc
tests/bits/find_cell_11.cc
tests/bits/find_cell_12.cc
tests/bits/find_cell_2.cc
tests/bits/find_cell_3.cc
tests/bits/find_cell_4.cc
tests/bits/find_cell_5.cc
tests/bits/find_cell_6.cc
tests/bits/find_cell_8.cc
tests/bits/find_cell_9.cc
tests/bits/find_cell_alt_1.cc
tests/bits/find_cell_alt_2.cc
tests/bits/find_cell_alt_3.cc
tests/bits/find_cell_alt_4.cc
tests/bits/find_cell_alt_5.cc
tests/bits/find_cell_alt_6.cc
tests/bits/find_cell_alt_7.cc
tests/bits/find_cells_adjacent_to_vertex_1.cc
tests/bits/joa_1.cc
tests/bits/neighboring_cells_at_two_faces.cc
tests/bits/normals_1.cc
tests/bits/normals_2.cc
tests/bits/normals_3.cc
tests/bits/normals_4.cc
tests/bits/periodicity_01.cc
tests/bits/periodicity_05.cc
tests/bits/periodicity_06.cc
tests/bits/periodicity_07.cc
tests/bits/periodicity_09.cc
tests/bits/point_difference_01.cc
tests/bits/point_difference_02.cc
tests/bits/point_gradient_01.cc
tests/bits/point_gradient_02.cc
tests/bits/point_gradient_hp_01.cc
tests/bits/point_gradient_hp_02.cc
tests/bits/point_value_01.cc
tests/bits/point_value_02.cc
tests/bits/point_value_hp_01.cc
tests/bits/point_value_hp_02.cc
tests/bits/q_point_sum_1.cc
tests/bits/q_point_sum_2.cc
tests/bits/q_point_sum_3.cc
tests/bits/q_point_sum_4.cc
tests/bits/q_points.cc
tests/bits/roy_1.cc
tests/bits/rt_2.cc
tests/bits/solution_transfer.cc
tests/bits/static_condensation.cc
tests/bits/step-10-high-order.cc
tests/bits/step-10.cc
tests/bits/step-11.cc
tests/bits/step-12.cc
tests/bits/step-13.cc
tests/bits/step-14.cc
tests/bits/step-16.cc
tests/bits/step-2.cc
tests/bits/step-4.cc
tests/bits/step-4_dg_periodic.cc
tests/bits/step-4_dg_periodic_coupling.cc
tests/bits/step-51.cc
tests/bits/step-51p.cc
tests/bits/step-6-racoptimize-2.cc
tests/bits/step-6-racoptimize.cc
tests/bits/step-7.cc
tests/bits/step-8.cc
tests/bits/subface_interpolation.cc
tests/bits/volume_1.cc
tests/bits/volume_2.cc
tests/bits/volume_3.cc
tests/bits/volume_4.cc
tests/boost/bounding_box_adaptor_01.cc
tests/boost/point_adaptor_01.cc
tests/boost/rtree_01.cc
tests/codim_one/bem.cc
tests/codim_one/bem_integration.cc
tests/codim_one/boundary_indicator_01.cc
tests/codim_one/direction_flag_01.cc
tests/codim_one/direction_flag_02.cc
tests/codim_one/direction_flag_03.cc
tests/codim_one/extract_boundary_mesh_00.cc
tests/codim_one/extract_boundary_mesh_01.cc
tests/codim_one/extract_boundary_mesh_02.cc
tests/codim_one/extract_boundary_mesh_03.cc
tests/codim_one/extract_boundary_mesh_04.cc
tests/codim_one/extract_boundary_mesh_05.cc
tests/codim_one/extract_boundary_mesh_06.cc
tests/codim_one/extract_boundary_mesh_07.cc
tests/codim_one/extract_boundary_mesh_11.cc
tests/codim_one/extract_boundary_mesh_13.cc
tests/codim_one/extract_boundary_mesh_15.cc
tests/codim_one/fe_dgq_prolongation_01.cc
tests/codim_one/gradients.cc
tests/codim_one/grid_refinement.cc
tests/codim_one/hanging_nodes_02.cc
tests/codim_one/hanging_nodes_03.cc
tests/codim_one/integrate_one_over_r_telles.cc
tests/codim_one/integrate_one_over_r_telles_middle.cc
tests/codim_one/interpolate_boundary_values_01.cc
tests/codim_one/interpolate_boundary_values_01_vector_valued.cc
tests/codim_one/interpolate_boundary_values_02.cc
tests/codim_one/interpolate_boundary_values_02_vector_valued.cc
tests/codim_one/interpolate_boundary_values_03.cc
tests/codim_one/interpolate_boundary_values_1d_closed_ring.cc
tests/codim_one/solution_transfer_01.cc
tests/codim_one/surface.cc
tests/cuda/matrix_vector_common.h
tests/data_out/data_out_01.cc
tests/data_out/data_out_02.cc
tests/data_out/data_out_03.cc
tests/data_out/data_out_04.cc
tests/data_out/data_out_05.cc
tests/data_out/data_out_06.cc
tests/data_out/data_out_07.cc
tests/data_out/data_out_08.cc
tests/data_out/data_out_08_set_cell_selection_01.cc
tests/data_out/data_out_08_set_cell_selection_02.cc
tests/data_out/data_out_08_set_cell_selection_03.cc
tests/data_out/data_out_12.cc
tests/data_out/data_out_13.cc
tests/data_out/data_out_base.cc
tests/data_out/data_out_base_dx.cc
tests/data_out/data_out_base_eps.cc
tests/data_out/data_out_base_gmv.cc
tests/data_out/data_out_base_gnuplot.cc
tests/data_out/data_out_base_gnuplot_02.cc
tests/data_out/data_out_base_gnuplot_labels.cc
tests/data_out/data_out_base_gnuplot_labels_02.cc
tests/data_out/data_out_base_povray.cc
tests/data_out/data_out_base_pvd.cc
tests/data_out/data_out_base_pvtu.cc
tests/data_out/data_out_base_tecplot.cc
tests/data_out/data_out_base_tecplot_bin.cc
tests/data_out/data_out_base_vtk.cc
tests/data_out/data_out_base_vtk_02.cc
tests/data_out/data_out_base_vtk_cycle.cc
tests/data_out/data_out_base_vtk_time.cc
tests/data_out/data_out_base_vtk_time_and_cycle.cc
tests/data_out/data_out_base_vtu.cc
tests/data_out/data_out_base_vtu_02.cc
tests/data_out/data_out_base_vtu_04.cc
tests/data_out/data_out_base_vtu_compression_levels.cc
tests/data_out/data_out_base_vtu_cycle.cc
tests/data_out/data_out_base_vtu_time.cc
tests/data_out/data_out_base_vtu_time_and_cycle.cc
tests/data_out/data_out_complex_05.cc
tests/data_out/data_out_complex_05_tensor.cc
tests/data_out/data_out_complex_06.cc
tests/data_out/data_out_complex_postprocessor_01.cc
tests/data_out/data_out_complex_postprocessor_03.cc
tests/data_out/data_out_curved_cells.cc
tests/data_out/data_out_faces_01.cc
tests/data_out/data_out_faces_02.cc
tests/data_out/data_out_faces_03.cc
tests/data_out/data_out_faces_04.cc
tests/data_out/data_out_faces_05.cc
tests/data_out/data_out_hdf5_02.cc
tests/data_out/data_out_multi_dh_01.cc
tests/data_out/data_out_multi_dh_02.cc
tests/data_out/data_out_multi_dh_03.cc
tests/data_out/data_out_multi_dh_04.cc
tests/data_out/data_out_multi_dh_05.cc
tests/data_out/data_out_postprocessor_tensor_01.cc
tests/data_out/data_out_postprocessor_vector_03.cc
tests/data_out/data_out_postprocessor_vector_complex_01.cc
tests/data_out/data_out_reader_01.cc
tests/data_out/data_out_rotation_01.cc
tests/data_out/data_out_rotation_02.cc
tests/data_out/data_out_rotation_03.cc
tests/data_out/data_out_rotation_04.cc
tests/data_out/data_out_rotation_05.cc
tests/data_out/data_out_stack_01.cc
tests/data_out/data_out_stack_02.cc
tests/data_out/patches.h
tests/distributed_grids/2d_coarse_grid_01.cc
tests/distributed_grids/2d_coarse_grid_02.cc
tests/distributed_grids/2d_coarse_grid_03.cc
tests/distributed_grids/2d_coarse_grid_04.cc
tests/distributed_grids/2d_coarsening_01.cc
tests/distributed_grids/2d_coarsening_02.cc
tests/distributed_grids/2d_coarsening_03.cc
tests/distributed_grids/2d_coarsening_05.cc
tests/distributed_grids/2d_dofhandler_01.cc
tests/distributed_grids/2d_refinement_01.cc
tests/distributed_grids/2d_refinement_02.cc
tests/distributed_grids/2d_refinement_03.cc
tests/distributed_grids/2d_refinement_04.cc
tests/distributed_grids/2d_refinement_05.cc
tests/distributed_grids/2d_refinement_06.cc
tests/distributed_grids/2d_refinement_07.cc
tests/distributed_grids/2d_refinement_10.cc
tests/distributed_grids/3d_coarse_grid_01.cc
tests/distributed_grids/3d_coarse_grid_02.cc
tests/distributed_grids/3d_coarse_grid_03.cc
tests/distributed_grids/3d_coarse_grid_04.cc
tests/distributed_grids/3d_coarse_grid_05.cc
tests/distributed_grids/3d_coarse_grid_06.cc
tests/distributed_grids/3d_coarsening_01.cc
tests/distributed_grids/3d_coarsening_02.cc
tests/distributed_grids/3d_coarsening_03.cc
tests/distributed_grids/3d_coarsening_04.cc
tests/distributed_grids/3d_coarsening_05.cc
tests/distributed_grids/3d_refinement_01.cc
tests/distributed_grids/3d_refinement_02.cc
tests/distributed_grids/3d_refinement_03.cc
tests/distributed_grids/3d_refinement_04.cc
tests/distributed_grids/3d_refinement_05.cc
tests/distributed_grids/3d_refinement_06.cc
tests/distributed_grids/3d_refinement_07.cc
tests/distributed_grids/3d_refinement_08.cc
tests/distributed_grids/3d_refinement_09.cc
tests/distributed_grids/3d_refinement_12.cc
tests/distributed_grids/anisotropic.cc
tests/distributed_grids/codim_01.cc
tests/distributed_grids/count_dofs_per_block_01.cc
tests/distributed_grids/count_dofs_per_component_01.cc
tests/distributed_grids/dof_handler_number_cache.cc
tests/distributed_grids/grid_tools_exchange_cell_data_04.cc
tests/distributed_grids/hp_2d_dofhandler_01.cc
tests/distributed_grids/hp_count_dofs_per_block_01.cc
tests/distributed_grids/hp_count_dofs_per_component_01.cc
tests/distributed_grids/hp_dof_handler_number_cache.cc
tests/distributed_grids/intergrid_transfer_representation_parallel.cc
tests/distributed_grids/solution_transfer_01.cc
tests/distributed_grids/solution_transfer_02.cc
tests/distributed_grids/solution_transfer_03.cc
tests/distributed_grids/solution_transfer_04.cc
tests/distributed_grids/tria_settings_01.cc
tests/distributed_grids/update_number_cache_01.cc
tests/dofs/block_info.cc
tests/dofs/block_info_02.cc
tests/dofs/block_list.h
tests/dofs/block_list_01.cc
tests/dofs/block_list_02.cc
tests/dofs/block_list_03.cc
tests/dofs/block_list_04.cc
tests/dofs/block_list_05.cc
tests/dofs/block_list_parallel_01.cc
tests/dofs/dof_handler_number_cache.cc
tests/dofs/dof_handler_number_cache_02.cc
tests/dofs/dof_renumbering.cc
tests/dofs/dof_renumbering_02.cc
tests/dofs/dof_renumbering_03.cc
tests/dofs/dof_renumbering_04.cc
tests/dofs/dof_renumbering_04a.cc
tests/dofs/dof_renumbering_05.cc
tests/dofs/dof_renumbering_06.cc
tests/dofs/dof_renumbering_07.cc
tests/dofs/dof_renumbering_08.cc
tests/dofs/dof_renumbering_zorder_01.cc
tests/dofs/dof_renumbering_zorder_02.cc
tests/dofs/dof_tools_00a.cc
tests/dofs/dof_tools_01a.cc
tests/dofs/dof_tools_01a_constraints_false.cc
tests/dofs/dof_tools_01a_constraints_true.cc
tests/dofs/dof_tools_01a_subdomain.cc
tests/dofs/dof_tools_01b.cc
tests/dofs/dof_tools_01c.cc
tests/dofs/dof_tools_01d.cc
tests/dofs/dof_tools_02a.cc
tests/dofs/dof_tools_02a_constraints_false.cc
tests/dofs/dof_tools_02a_constraints_true.cc
tests/dofs/dof_tools_02a_subdomain.cc
tests/dofs/dof_tools_02b.cc
tests/dofs/dof_tools_02c.cc
tests/dofs/dof_tools_02d.cc
tests/dofs/dof_tools_03.cc
tests/dofs/dof_tools_04.cc
tests/dofs/dof_tools_04a.cc
tests/dofs/dof_tools_05.cc
tests/dofs/dof_tools_06.cc
tests/dofs/dof_tools_07.cc
tests/dofs/dof_tools_08.cc
tests/dofs/dof_tools_09.cc
tests/dofs/dof_tools_10.cc
tests/dofs/dof_tools_12.cc
tests/dofs/dof_tools_12a.cc
tests/dofs/dof_tools_13.cc
tests/dofs/dof_tools_13a.cc
tests/dofs/dof_tools_14.cc
tests/dofs/dof_tools_15a.cc
tests/dofs/dof_tools_15b.cc
tests/dofs/dof_tools_15c.cc
tests/dofs/dof_tools_15d.cc
tests/dofs/dof_tools_16a.cc
tests/dofs/dof_tools_16b.cc
tests/dofs/dof_tools_16c.cc
tests/dofs/dof_tools_16d.cc
tests/dofs/dof_tools_17a.cc
tests/dofs/dof_tools_17b.cc
tests/dofs/dof_tools_17c.cc
tests/dofs/dof_tools_17d.cc
tests/dofs/dof_tools_18a.cc
tests/dofs/dof_tools_18a_1d.cc
tests/dofs/dof_tools_18b.cc
tests/dofs/dof_tools_18c.cc
tests/dofs/dof_tools_18d.cc
tests/dofs/dof_tools_19.cc
tests/dofs/dof_tools_20.cc
tests/dofs/dof_tools_21.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/dof_tools_22a.cc
tests/dofs/dof_tools_23.cc
tests/dofs/dof_tools_24.cc
tests/dofs/dof_tools_25.cc
tests/dofs/dof_tools_common.h
tests/dofs/dof_tools_periodic.h
tests/dofs/extract_dofs_by_component_01.cc
tests/dofs/extract_dofs_by_component_01_hp.cc
tests/dofs/extract_dofs_by_component_01_mg.cc
tests/dofs/extract_dofs_by_component_01x.cc
tests/dofs/extract_dofs_by_component_01y.cc
tests/dofs/extract_dofs_by_component_02.cc
tests/dofs/extract_dofs_by_component_02_hp.cc
tests/dofs/extract_dofs_by_component_02_mg.cc
tests/dofs/extract_dofs_by_component_03.cc
tests/dofs/extract_dofs_by_component_04.cc
tests/dofs/extract_dofs_by_component_05.cc
tests/dofs/extract_dofs_by_component_05_hp.cc
tests/dofs/extract_dofs_by_component_06.cc
tests/dofs/extract_dofs_by_component_06_hp.cc
tests/dofs/extract_dofs_per_component_01.cc
tests/dofs/extract_dofs_per_component_02.cc
tests/dofs/hp_constraints_are_implemented.cc
tests/dofs/interpolate_based_on_material_id_01.cc
tests/dofs/interpolate_dgq_01.cc
tests/dofs/interpolate_dgq_02.cc
tests/dofs/interpolate_q_01.cc
tests/dofs/interpolate_q_02.cc
tests/dofs/interpolate_q_system_01.cc
tests/dofs/interpolate_q_system_02.cc
tests/dofs/interpolate_q_system_mask_01.cc
tests/dofs/interpolate_q_system_mask_02.cc
tests/dofs/locally_owned_dofs_per_subdomain_01.cc
tests/dofs/map_dofs_to_support_points_01.cc
tests/dofs/mg_dof_handler.cc
tests/dofs/n_boundary_dofs_01.cc
tests/dofs/n_dofs_per_object.cc
tests/dofs/range_based_for_dof_face.cc
tests/dofs/range_based_for_step-6.cc
tests/dofs/range_based_for_tria_face.cc
tests/dofs/sparsity_pattern.cc
tests/dofs/sparsity_pattern_01.cc
tests/dofs/sparsity_pattern_02.cc
tests/dofs/sparsity_pattern_03.cc
tests/dofs/sparsity_pattern_04.cc
tests/dofs/sparsity_pattern_05.cc
tests/dofs/sparsity_pattern_06.cc
tests/dofs/sparsity_pattern_07.cc
tests/epetraext/sparse_matrix_mmult_01.cc
tests/epetraext/sparse_matrix_mmult_02.cc
tests/examples/step-56.cc
tests/fail/circular_01.cc
tests/fail/fe_nothing_04.cc
tests/fail/hp-step-14.cc
tests/fail/rt_6.cc
tests/fail/rt_crash_01.cc
tests/fail/scalapack_15_b.cc
tests/fail/step-15.cc
tests/fe/abf_01.cc
tests/fe/abf_02.cc
tests/fe/abf_degree.cc
tests/fe/block_mask_01.cc
tests/fe/block_mask_02.cc
tests/fe/block_mask_03.cc
tests/fe/block_mask_04.cc
tests/fe/block_mask_05.cc
tests/fe/block_mask_06.cc
tests/fe/block_mask_07.cc
tests/fe/block_mask_08.cc
tests/fe/block_mask_09.cc
tests/fe/block_mask_10.cc
tests/fe/block_mask_11.cc
tests/fe/br_approximation_01.cc
tests/fe/cell_similarity_01.cc
tests/fe/cell_similarity_02.cc
tests/fe/cell_similarity_03.cc
tests/fe/cell_similarity_04.cc
tests/fe/cell_similarity_05.cc
tests/fe/cell_similarity_06.cc
tests/fe/cell_similarity_07.cc
tests/fe/cell_similarity_08.cc
tests/fe/cell_similarity_09.cc
tests/fe/cell_similarity_10.cc
tests/fe/cell_similarity_11.cc
tests/fe/cell_similarity_dgp_monomial_01.cc
tests/fe/cell_similarity_dgp_monomial_02.cc
tests/fe/cell_similarity_dgp_monomial_03.cc
tests/fe/cell_similarity_dgp_monomial_04.cc
tests/fe/cell_similarity_dgp_monomial_05.cc
tests/fe/cell_similarity_dgp_monomial_06.cc
tests/fe/cell_similarity_dgp_monomial_07.cc
tests/fe/cell_similarity_dgp_monomial_08.cc
tests/fe/cell_similarity_dgp_monomial_09.cc
tests/fe/cell_similarity_dgp_monomial_10.cc
tests/fe/cell_similarity_dgp_nonparametric_01.cc
tests/fe/cell_similarity_dgp_nonparametric_02.cc
tests/fe/cell_similarity_dgp_nonparametric_03.cc
tests/fe/cell_similarity_dgp_nonparametric_04.cc
tests/fe/cell_similarity_dgp_nonparametric_05.cc
tests/fe/cell_similarity_dgp_nonparametric_06.cc
tests/fe/cell_similarity_dgp_nonparametric_07.cc
tests/fe/cell_similarity_dgp_nonparametric_08.cc
tests/fe/cell_similarity_dgp_nonparametric_09.cc
tests/fe/cell_similarity_dgp_nonparametric_10.cc
tests/fe/check_derivatives.cc
tests/fe/component_mask_01.cc
tests/fe/component_mask_02.cc
tests/fe/component_mask_03.cc
tests/fe/component_mask_04.cc
tests/fe/component_mask_05.cc
tests/fe/component_mask_06.cc
tests/fe/component_mask_07.cc
tests/fe/component_mask_08.cc
tests/fe/component_mask_09.cc
tests/fe/component_mask_10.cc
tests/fe/component_mask_11.cc
tests/fe/component_mask_12.cc
tests/fe/component_mask_13.cc
tests/fe/component_mask_14.cc
tests/fe/curl_curl_01.cc
tests/fe/deformed_projection.h
tests/fe/derivatives.cc
tests/fe/derivatives_bernstein.cc
tests/fe/derivatives_face.cc
tests/fe/dgp_01.cc
tests/fe/element_constant_modes.cc
tests/fe/fe_abf_gradient_divergence_theorem.cc
tests/fe/fe_br.cc
tests/fe/fe_compute_point_locations_01.cc
tests/fe/fe_data_test.cc
tests/fe/fe_dgp_3rd_derivative_divergence_theorem.cc
tests/fe/fe_dgq_3rd_derivative_divergence_theorem.cc
tests/fe/fe_dgq_gradient_divergence_theorem.cc
tests/fe/fe_dgq_hessian_divergence_theorem.cc
tests/fe/fe_enriched_01.cc
tests/fe/fe_enriched_02.cc
tests/fe/fe_enriched_03.cc
tests/fe/fe_enriched_04.cc
tests/fe/fe_enriched_05.cc
tests/fe/fe_enriched_06.cc
tests/fe/fe_enriched_07.cc
tests/fe/fe_enriched_08.cc
tests/fe/fe_enriched_08a.cc
tests/fe/fe_enriched_color_01.cc
tests/fe/fe_enriched_color_07.cc
tests/fe/fe_enriched_compare_to_fe_system.cc
tests/fe/fe_enriched_compare_to_fe_system_2.cc
tests/fe/fe_enriched_step-36.cc
tests/fe/fe_enriched_step-36b.cc
tests/fe/fe_face_orientation_nedelec.h
tests/fe/fe_face_orientation_nedelec_0.cc
tests/fe/fe_face_values_1d.cc
tests/fe/fe_faceq_interpolate.cc
tests/fe/fe_nedelec_gradient_divergence_theorem.cc
tests/fe/fe_nedelec_hessian_divergence_theorem.cc
tests/fe/fe_nedelec_singularity_01.cc
tests/fe/fe_nedelec_singularity_02.cc
tests/fe/fe_nedelec_sz_face_values.cc
tests/fe/fe_nedelec_sz_gradient_divergence_theorem.cc
tests/fe/fe_nedelec_sz_non_rect_2d.cc
tests/fe/fe_nedelec_sz_non_rect_face.cc
tests/fe/fe_nothing.cc
tests/fe/fe_project_2d.cc
tests/fe/fe_project_3d.cc
tests/fe/fe_prolongation_bdm.cc
tests/fe/fe_prolongation_dgp.cc
tests/fe/fe_prolongation_dgq.cc
tests/fe/fe_prolongation_nedelec.cc
tests/fe/fe_prolongation_q.cc
tests/fe/fe_prolongation_q_bubbles.cc
tests/fe/fe_prolongation_q_dg0.cc
tests/fe/fe_prolongation_q_hierarchical.cc
tests/fe/fe_prolongation_q_iso_q1.cc
tests/fe/fe_prolongation_rt.cc
tests/fe/fe_prolongation_sys_01.cc
tests/fe/fe_prolongation_sys_02.cc
tests/fe/fe_prolongation_sys_03.cc
tests/fe/fe_prolongation_sys_04.cc
tests/fe/fe_prolongation_sys_05.cc
tests/fe/fe_prolongation_sys_06.cc
tests/fe/fe_prolongation_sys_07.cc
tests/fe/fe_prolongation_sys_08.cc
tests/fe/fe_prolongation_sys_09.cc
tests/fe/fe_prolongation_sys_10.cc
tests/fe/fe_q_3rd_derivative_divergence_theorem.cc
tests/fe/fe_q_bubbles.cc
tests/fe/fe_q_dg0.cc
tests/fe/fe_q_gradient_divergence_theorem.cc
tests/fe/fe_q_hessian_divergence_theorem.cc
tests/fe/fe_q_hierarchical_3rd_derivative_divergence_theorem.cc
tests/fe/fe_restriction_bdm.cc
tests/fe/fe_restriction_dgp.cc
tests/fe/fe_restriction_dgq.cc
tests/fe/fe_restriction_nedelec.cc
tests/fe/fe_restriction_q.cc
tests/fe/fe_restriction_q_bubbles.cc
tests/fe/fe_restriction_q_dg0.cc
tests/fe/fe_restriction_q_hierarchical.cc
tests/fe/fe_restriction_q_iso_q1.cc
tests/fe/fe_restriction_rt.cc
tests/fe/fe_restriction_sys_01.cc
tests/fe/fe_restriction_sys_02.cc
tests/fe/fe_restriction_sys_03.cc
tests/fe/fe_restriction_sys_04.cc
tests/fe/fe_restriction_sys_05.cc
tests/fe/fe_restriction_sys_06.cc
tests/fe/fe_restriction_sys_07.cc
tests/fe/fe_restriction_sys_08.cc
tests/fe/fe_restriction_sys_09.cc
tests/fe/fe_restriction_sys_10.cc
tests/fe/fe_rt_gradient_divergence_theorem.cc
tests/fe/fe_rt_hessian_divergence_theorem.cc
tests/fe/fe_series_01.cc
tests/fe/fe_series_02.cc
tests/fe/fe_series_03.cc
tests/fe/fe_series_04.cc
tests/fe/fe_series_05.cc
tests/fe/fe_series_06.cc
tests/fe/fe_series_07.cc
tests/fe/fe_series_08.cc
tests/fe/fe_subface_values_01.cc
tests/fe/fe_support_points_bdm.cc
tests/fe/fe_support_points_common.h
tests/fe/fe_support_points_nedelec.cc
tests/fe/fe_support_points_q.cc
tests/fe/fe_support_points_q_bubbles.cc
tests/fe/fe_support_points_q_dg0.cc
tests/fe/fe_support_points_q_hierarchical.cc
tests/fe/fe_support_points_q_iso_q1.cc
tests/fe/fe_support_points_rt.cc
tests/fe/fe_support_points_sys_01.cc
tests/fe/fe_support_points_sys_02.cc
tests/fe/fe_support_points_sys_03.cc
tests/fe/fe_support_points_sys_04.cc
tests/fe/fe_support_points_sys_05.cc
tests/fe/fe_support_points_sys_06.cc
tests/fe/fe_support_points_sys_07.cc
tests/fe/fe_support_points_sys_08.cc
tests/fe/fe_support_points_sys_09.cc
tests/fe/fe_support_points_sys_10.cc
tests/fe/fe_system_3rd_derivative_divergence_theorem.cc
tests/fe/fe_system_generalized_support_points.cc
tests/fe/fe_tools.cc
tests/fe/fe_tools_01.cc
tests/fe/fe_traceq_interpolate.cc
tests/fe/fe_values_extractor_01.cc
tests/fe/fe_values_function_manifold.cc
tests/fe/fe_values_no_mapping.cc
tests/fe/fe_values_view_01.cc
tests/fe/fe_values_view_02.cc
tests/fe/fe_values_view_03.cc
tests/fe/fe_values_view_04.cc
tests/fe/fe_values_view_05.cc
tests/fe/fe_values_view_06.cc
tests/fe/fe_values_view_07.cc
tests/fe/fe_values_view_08.cc
tests/fe/fe_values_view_09.cc
tests/fe/fe_values_view_10.cc
tests/fe/fe_values_view_10_single_01.cc
tests/fe/fe_values_view_10_single_02.cc
tests/fe/fe_values_view_10_single_03.cc
tests/fe/fe_values_view_11.cc
tests/fe/fe_values_view_12.cc
tests/fe/fe_values_view_13.cc
tests/fe/fe_values_view_14.cc
tests/fe/fe_values_view_15.cc
tests/fe/fe_values_view_16.cc
tests/fe/fe_values_view_17.cc
tests/fe/fe_values_view_18.cc
tests/fe/fe_values_view_19.cc
tests/fe/fe_values_view_20.cc
tests/fe/fe_values_view_21.cc
tests/fe/fe_values_view_21_nonsymmetric.cc
tests/fe/fe_values_view_22.cc
tests/fe/fe_values_view_23.cc
tests/fe/fe_values_view_23_nonsymmetric.cc
tests/fe/fe_values_view_24.cc
tests/fe/fe_values_view_24_nonsymmetric.cc
tests/fe/fe_values_view_25.cc
tests/fe/fe_values_view_25_nonsymmetric.cc
tests/fe/fe_values_view_25b_nonsymmetric.cc
tests/fe/fe_values_view_26.cc
tests/fe/fe_values_view_27.cc
tests/fe/fe_values_view_28.cc
tests/fe/fe_values_view_29.cc
tests/fe/fe_values_view_30.cc
tests/fe/fe_values_view_invalid_01.cc
tests/fe/fe_values_view_invalid_02.cc
tests/fe/fe_values_view_invalid_03.cc
tests/fe/fe_values_view_invalid_03_nonsymmetric.cc
tests/fe/fe_values_view_tensor_01.cc
tests/fe/interpolate_nedelec.cc
tests/fe/interpolate_q1.cc
tests/fe/interpolate_q_bubbles.cc
tests/fe/interpolate_q_dg0.cc
tests/fe/interpolate_q_iso_q1.cc
tests/fe/interpolate_q_system_mixed_01.cc
tests/fe/interpolate_rt.cc
tests/fe/interpolate_rtn.cc
tests/fe/interpolate_system.cc
tests/fe/jacobians.cc
tests/fe/jacobians_face.cc
tests/fe/jacobians_face_cartesian.cc
tests/fe/jacobians_face_fe_field.cc
tests/fe/multiple_redistribute_dofs_01.cc
tests/fe/multiple_redistribute_dofs_02.cc
tests/fe/nedelec_2.cc
tests/fe/nedelec_crash_01.cc
tests/fe/nedelec_face_interpolation.cc
tests/fe/nedelec_non_rect_2d.cc
tests/fe/nedelec_non_rect_face.cc
tests/fe/non_primitive_1.cc
tests/fe/non_primitive_2.cc
tests/fe/numbering.cc
tests/fe/p1nc_01.cc
tests/fe/p1nc_02.cc
tests/fe/p1nc_03.cc
tests/fe/p1nc_04.cc
tests/fe/p1nc_05.cc
tests/fe/p1nc_06.cc
tests/fe/p1nc_07.cc
tests/fe/p1nc_08.cc
tests/fe/restrict_prolongation_01.cc
tests/fe/rt_approximation_01.cc
tests/fe/rt_covariant.cc
tests/fe/rt_hessian.cc
tests/fe/rt_normal_02.cc
tests/fe/rtdiff.cc
tests/fe/rtn_1.cc
tests/fe/shapes.h
tests/fe/shapes_bernstein.cc
tests/fe/shapes_dgp.cc
tests/fe/shapes_dgp_monomial.cc
tests/fe/shapes_dgp_nonparametric.cc
tests/fe/shapes_dgq.cc
tests/fe/shapes_faceq.cc
tests/fe/shapes_nedelec.cc
tests/fe/shapes_q.cc
tests/fe/shapes_q_bubbles.cc
tests/fe/shapes_q_dg0.cc
tests/fe/shapes_q_hierarchical.cc
tests/fe/shapes_q_iso_q1.cc
tests/fe/shapes_system.cc
tests/fe/shapes_system_02.cc
tests/fe/shapes_traceq.cc
tests/fe/transfer.cc
tests/fe/up_and_down.cc
tests/feinterface/face_orientation_01.cc
tests/feinterface/fe_interface_values_01.cc
tests/feinterface/fe_interface_values_02.cc
tests/feinterface/fe_interface_values_03.cc
tests/feinterface/fe_interface_values_04.cc
tests/feinterface/fe_interface_values_05.cc
tests/feinterface/fe_interface_values_06.cc
tests/feinterface/fe_interface_values_07.cc
tests/feinterface/fe_interface_values_08.cc
tests/feinterface/fe_interface_values_09.cc
tests/feinterface/step-12.cc
tests/full_matrix/complex_complex_full_matrix_01.cc
tests/full_matrix/complex_complex_full_matrix_02.cc
tests/full_matrix/complex_complex_full_matrix_03.cc
tests/full_matrix/complex_complex_full_matrix_04.cc
tests/full_matrix/complex_complex_full_matrix_06.cc
tests/full_matrix/complex_complex_full_matrix_07.cc
tests/full_matrix/complex_complex_full_matrix_08.cc
tests/full_matrix/complex_complex_full_matrix_10.cc
tests/full_matrix/complex_complex_full_matrix_11.cc
tests/full_matrix/complex_complex_full_matrix_12.cc
tests/full_matrix/complex_complex_full_matrix_13.cc
tests/full_matrix/complex_complex_full_matrix_14.cc
tests/full_matrix/complex_complex_full_matrix_15.cc
tests/full_matrix/complex_complex_full_matrix_16.cc
tests/full_matrix/complex_complex_full_matrix_17.cc
tests/full_matrix/complex_complex_full_matrix_18.cc
tests/full_matrix/complex_complex_full_matrix_19.cc
tests/full_matrix/complex_complex_full_matrix_20.cc
tests/full_matrix/complex_complex_full_matrix_21.cc
tests/full_matrix/complex_complex_full_matrix_22.cc
tests/full_matrix/complex_complex_full_matrix_23.cc
tests/full_matrix/complex_complex_full_matrix_24.cc
tests/full_matrix/complex_complex_full_matrix_25.cc
tests/full_matrix/complex_complex_full_matrix_26.cc
tests/full_matrix/complex_complex_full_matrix_27.cc
tests/full_matrix/complex_complex_full_matrix_28.cc
tests/full_matrix/complex_complex_full_matrix_29.cc
tests/full_matrix/complex_complex_full_matrix_30.cc
tests/full_matrix/complex_complex_full_matrix_31.cc
tests/full_matrix/complex_complex_full_matrix_32.cc
tests/full_matrix/complex_complex_full_matrix_33.cc
tests/full_matrix/complex_complex_full_matrix_34.cc
tests/full_matrix/complex_complex_full_matrix_36.cc
tests/full_matrix/complex_complex_full_matrix_37.cc
tests/full_matrix/complex_complex_full_matrix_38.cc
tests/full_matrix/complex_complex_full_matrix_39.cc
tests/full_matrix/complex_complex_full_matrix_40.cc
tests/full_matrix/complex_complex_full_matrix_41.cc
tests/full_matrix/complex_complex_full_matrix_42.cc
tests/full_matrix/complex_complex_full_matrix_43.cc
tests/full_matrix/complex_complex_full_matrix_44.cc
tests/full_matrix/complex_complex_full_matrix_45.cc
tests/full_matrix/complex_complex_full_matrix_46.cc
tests/full_matrix/complex_complex_full_matrix_47.cc
tests/full_matrix/complex_complex_full_matrix_48.cc
tests/full_matrix/complex_complex_full_matrix_49.cc
tests/full_matrix/complex_complex_full_matrix_50.cc
tests/full_matrix/complex_complex_full_matrix_51.cc
tests/full_matrix/complex_complex_full_matrix_52.cc
tests/full_matrix/complex_real_full_matrix_01.cc
tests/full_matrix/complex_real_full_matrix_02.cc
tests/full_matrix/complex_real_full_matrix_03.cc
tests/full_matrix/complex_real_full_matrix_04.cc
tests/full_matrix/complex_real_full_matrix_05.cc
tests/full_matrix/complex_real_full_matrix_06.cc
tests/full_matrix/complex_real_full_matrix_07.cc
tests/full_matrix/complex_real_full_matrix_08.cc
tests/full_matrix/complex_real_full_matrix_09.cc
tests/full_matrix/complex_real_full_matrix_10.cc
tests/full_matrix/complex_real_full_matrix_11.cc
tests/full_matrix/complex_real_full_matrix_12.cc
tests/full_matrix/complex_real_full_matrix_13.cc
tests/full_matrix/complex_real_full_matrix_14.cc
tests/full_matrix/complex_real_full_matrix_15.cc
tests/full_matrix/complex_real_full_matrix_16.cc
tests/full_matrix/complex_real_full_matrix_17.cc
tests/full_matrix/complex_real_full_matrix_18.cc
tests/full_matrix/complex_real_full_matrix_19.cc
tests/full_matrix/complex_real_full_matrix_20.cc
tests/full_matrix/complex_real_full_matrix_21.cc
tests/full_matrix/complex_real_full_matrix_22.cc
tests/full_matrix/complex_real_full_matrix_23.cc
tests/full_matrix/complex_real_full_matrix_24.cc
tests/full_matrix/complex_real_full_matrix_25.cc
tests/full_matrix/complex_real_full_matrix_26.cc
tests/full_matrix/complex_real_full_matrix_27.cc
tests/full_matrix/complex_real_full_matrix_28.cc
tests/full_matrix/complex_real_full_matrix_29.cc
tests/full_matrix/complex_real_full_matrix_30.cc
tests/full_matrix/complex_real_full_matrix_31.cc
tests/full_matrix/complex_real_full_matrix_32.cc
tests/full_matrix/complex_real_full_matrix_33.cc
tests/full_matrix/complex_real_full_matrix_34.cc
tests/full_matrix/complex_real_full_matrix_36.cc
tests/full_matrix/complex_real_full_matrix_37.cc
tests/full_matrix/complex_real_full_matrix_38.cc
tests/full_matrix/complex_real_full_matrix_39.cc
tests/full_matrix/complex_real_full_matrix_40.cc
tests/full_matrix/complex_real_full_matrix_41.cc
tests/full_matrix/complex_real_full_matrix_42.cc
tests/full_matrix/complex_real_full_matrix_43.cc
tests/full_matrix/complex_real_full_matrix_44.cc
tests/full_matrix/complex_real_full_matrix_45.cc
tests/full_matrix/complex_real_full_matrix_46.cc
tests/full_matrix/complex_real_full_matrix_47.cc
tests/full_matrix/complex_real_full_matrix_48.cc
tests/full_matrix/complex_real_full_matrix_49.cc
tests/full_matrix/complex_real_full_matrix_50.cc
tests/full_matrix/complex_real_full_matrix_51.cc
tests/full_matrix/complex_real_full_matrix_52.cc
tests/full_matrix/full_matrix_01.cc
tests/full_matrix/full_matrix_12.cc
tests/full_matrix/full_matrix_13.cc
tests/full_matrix/full_matrix_14.cc
tests/full_matrix/full_matrix_15.cc
tests/full_matrix/full_matrix_16.cc
tests/full_matrix/full_matrix_17.cc
tests/full_matrix/full_matrix_18.cc
tests/full_matrix/full_matrix_19.cc
tests/full_matrix/full_matrix_20.cc
tests/full_matrix/full_matrix_21.cc
tests/full_matrix/full_matrix_22.cc
tests/full_matrix/full_matrix_23.cc
tests/full_matrix/full_matrix_24.cc
tests/full_matrix/full_matrix_25.cc
tests/full_matrix/full_matrix_26.cc
tests/full_matrix/full_matrix_27.cc
tests/full_matrix/full_matrix_28.cc
tests/full_matrix/full_matrix_29.cc
tests/full_matrix/full_matrix_30.cc
tests/full_matrix/full_matrix_31.cc
tests/full_matrix/full_matrix_32.cc
tests/full_matrix/full_matrix_33.cc
tests/full_matrix/full_matrix_34.cc
tests/full_matrix/full_matrix_36.cc
tests/full_matrix/full_matrix_37.cc
tests/full_matrix/full_matrix_38.cc
tests/full_matrix/full_matrix_39.cc
tests/full_matrix/full_matrix_40.cc
tests/full_matrix/full_matrix_41.cc
tests/full_matrix/full_matrix_42.cc
tests/full_matrix/full_matrix_43.cc
tests/full_matrix/full_matrix_44.cc
tests/full_matrix/full_matrix_45.cc
tests/full_matrix/full_matrix_46.cc
tests/full_matrix/full_matrix_47.cc
tests/full_matrix/full_matrix_48.cc
tests/full_matrix/full_matrix_49.cc
tests/full_matrix/full_matrix_50.cc
tests/full_matrix/full_matrix_51.cc
tests/full_matrix/full_matrix_52.cc
tests/full_matrix/full_matrix_53.cc
tests/full_matrix/full_matrix_54.cc
tests/full_matrix/full_matrix_55.cc
tests/full_matrix/full_matrix_56.cc
tests/full_matrix/full_matrix_57.cc
tests/full_matrix/full_matrix_59.cc
tests/full_matrix/full_matrix_60.cc
tests/full_matrix/full_matrix_61.cc
tests/full_matrix/full_matrix_62.cc
tests/full_matrix/full_matrix_63.cc
tests/full_matrix/full_matrix_64.cc
tests/full_matrix/full_matrix_65.cc
tests/full_matrix/full_matrix_66.cc
tests/full_matrix/full_matrix_67.cc
tests/full_matrix/full_matrix_68.cc
tests/full_matrix/full_matrix_determinant_01.cc
tests/full_matrix/full_matrix_invert_01.cc
tests/fullydistributed_grids/copy_distributed_tria_01.cc
tests/fullydistributed_grids/copy_distributed_tria_02.cc
tests/fullydistributed_grids/copy_distributed_tria_03.cc
tests/fullydistributed_grids/copy_serial_tria_01.cc
tests/fullydistributed_grids/copy_serial_tria_02.cc
tests/fullydistributed_grids/copy_serial_tria_03.cc
tests/fullydistributed_grids/copy_serial_tria_04.cc
tests/fullydistributed_grids/copy_serial_tria_05.cc
tests/fullydistributed_grids/copy_serial_tria_06.cc
tests/fullydistributed_grids/copy_serial_tria_07.cc
tests/fullydistributed_grids/copy_serial_tria_08.cc
tests/fullydistributed_grids/copy_serial_tria_09.cc
tests/fullydistributed_grids/copy_serial_tria_grouped_01.cc
tests/fullydistributed_grids/tests.h
tests/ginkgo/solver.cc
tests/gla/block_mat_01.cc
tests/gla/block_mat_02.cc
tests/gla/block_mat_03.cc
tests/gla/block_vec_01.cc
tests/gla/block_vec_02.cc
tests/gla/block_vec_03.cc
tests/gla/block_vec_04.cc
tests/gla/mat_01.cc
tests/gla/mat_02.cc
tests/gla/mat_03.cc
tests/gla/mat_04.cc
tests/gla/mat_05.cc
tests/gla/mat_06.cc
tests/gla/vec_00.cc
tests/gla/vec_01.cc
tests/gla/vec_02.cc
tests/gla/vec_03.cc
tests/gla/vec_04.cc
tests/gla/vec_05.cc
tests/gla/vec_06.cc
tests/gla/vec_07.cc
tests/gla/vec_all_zero_01.cc
tests/gmsh/create_tria_01.cc
tests/grid/accessor_01.cc
tests/grid/accessor_02.cc
tests/grid/build_global_description_tree.cc
tests/grid/cell_id_04.cc
tests/grid/cell_id_06.cc
tests/grid/coarsening_02.cc
tests/grid/coarsening_02_1d.cc
tests/grid/coarsening_03.cc
tests/grid/compute_point_locations_01.cc
tests/grid/compute_point_locations_02.cc
tests/grid/compute_point_locations_try_all_01.cc
tests/grid/concentric_hyper_shell_01.cc
tests/grid/concentric_hyper_shell_02.cc
tests/grid/distributed_compute_point_locations_01.cc
tests/grid/distributed_compute_point_locations_02.cc
tests/grid/distributed_compute_point_locations_03.cc
tests/grid/enclosing_sphere_01.cc
tests/grid/extrude_copy_manifold.cc
tests/grid/extrude_orientation_01.cc
tests/grid/extrude_orientation_02.cc
tests/grid/extrude_orientation_03.cc
tests/grid/face_orientations_3d.cc
tests/grid/filtered_iterator_06.cc
tests/grid/grid_generator_01.cc
tests/grid/grid_generator_01b.cc
tests/grid/grid_generator_10.cc
tests/grid/grid_generator_airfoil_01.cc
tests/grid/grid_generator_half_hyper_shell.cc
tests/grid/grid_generator_hyper_cube_slit_01.cc
tests/grid/grid_generator_hyper_sphere.cc
tests/grid/grid_generator_open_torus.cc
tests/grid/grid_generator_plate_with_a_hole.cc
tests/grid/grid_generator_plate_with_a_hole_2.cc
tests/grid/grid_generator_plate_with_a_hole_3.cc
tests/grid/grid_generator_plate_with_a_hole_4.cc
tests/grid/grid_hyper_shell.cc
tests/grid/grid_hyper_shell_05.cc
tests/grid/grid_hyper_shell_06.cc
tests/grid/grid_in.cc
tests/grid/grid_in_3d.cc
tests/grid/grid_in_3d_02.cc
tests/grid/grid_in_abaqus_01.cc
tests/grid/grid_in_abaqus_02.cc
tests/grid/grid_in_gmsh_01.cc
tests/grid/grid_in_gmsh_01_v4.cc
tests/grid/grid_in_gmsh_01_v41.cc
tests/grid/grid_in_msh_version_4.cc
tests/grid/grid_in_ucd_01.cc
tests/grid/grid_in_ucd_02.cc
tests/grid/grid_in_vtk_3d_04.cc
tests/grid/grid_invert.cc
tests/grid/grid_out_08.cc
tests/grid/grid_out_09.cc
tests/grid/grid_out_in_vtk_01.cc
tests/grid/grid_out_svg_01.cc
tests/grid/grid_out_svg_02.cc
tests/grid/grid_out_svg_03.cc
tests/grid/grid_out_vtk_03.cc
tests/grid/grid_parallelepiped_04.cc
tests/grid/grid_tools_05.cc
tests/grid/grid_tools_06.cc
tests/grid/grid_tools_aspect_ratio.cc
tests/grid/grid_tools_cache_04.cc
tests/grid/grid_tools_cache_05.cc
tests/grid/grid_tools_compute_mesh_predicate_bounding_box_1.cc
tests/grid/grid_transform.cc
tests/grid/grid_transform_02.cc
tests/grid/grid_transform_03.cc
tests/grid/grid_transform_3d.cc
tests/grid/grid_transform_coefficient.cc
tests/grid/intergrid_constraints.cc
tests/grid/intergrid_map.cc
tests/grid/merge_triangulations_02.cc
tests/grid/merge_triangulations_03.cc
tests/grid/merge_triangulations_04.cc
tests/grid/merge_triangulations_07.cc
tests/grid/mesh_3d_1.cc
tests/grid/mesh_3d_10.cc
tests/grid/mesh_3d_11.cc
tests/grid/mesh_3d_12.cc
tests/grid/mesh_3d_13.cc
tests/grid/mesh_3d_14.cc
tests/grid/mesh_3d_15.cc
tests/grid/mesh_3d_16.cc
tests/grid/mesh_3d_17.cc
tests/grid/mesh_3d_2.cc
tests/grid/mesh_3d_20.cc
tests/grid/mesh_3d_21.cc
tests/grid/mesh_3d_22.cc
tests/grid/mesh_3d_25.cc
tests/grid/mesh_3d_26.cc
tests/grid/mesh_3d_3.cc
tests/grid/mesh_3d_4.cc
tests/grid/mesh_3d_5.cc
tests/grid/mesh_3d_6.cc
tests/grid/mesh_3d_7.cc
tests/grid/mesh_3d_8.cc
tests/grid/mesh_3d_9.cc
tests/grid/mesh_smoothing_02.cc
tests/grid/mesh_smoothing_03.cc
tests/grid/n_faces_01.cc
tests/grid/normal_vector_01.cc
tests/grid/normal_vector_01_2d.cc
tests/grid/normal_vector_02.cc
tests/grid/normal_vector_02_2d.cc
tests/grid/normal_vector_03.cc
tests/grid/normal_vector_03_2d.cc
tests/grid/normals_at_vertices_01.cc
tests/grid/normals_at_vertices_02.cc
tests/grid/oned_vertex_manifold.cc
tests/grid/partition_triangulation_zorder_01.cc
tests/grid/periodicity_01.cc
tests/grid/project_to_object_01.cc
tests/grid/refine_and_coarsen_fixed_fraction_02.cc
tests/grid/refine_and_coarsen_fixed_number.cc
tests/grid/refine_and_coarsen_fixed_number_02.cc
tests/grid/refine_boundary_domain.cc
tests/grid/subcelldata.cc
tests/grid/user_data_01.cc
tests/hp/accessor_0.cc
tests/hp/copy_tria_bug.cc
tests/hp/count_dofs_per_block_01.cc
tests/hp/count_dofs_per_block_02.cc
tests/hp/crash_10.cc
tests/hp/crash_14.cc
tests/hp/crash_17.cc
tests/hp/crash_18.cc
tests/hp/crash_21.cc
tests/hp/distribute_dofs_linear_time.cc
tests/hp/do_function_derivatives_01.cc
tests/hp/do_function_hessians_01.cc
tests/hp/do_function_laplacians_01.cc
tests/hp/dof_handler_number_cache.cc
tests/hp/dof_renumbering_04.cc
tests/hp/dof_renumbering_05.cc
tests/hp/dof_renumbering_06.cc
tests/hp/fe_nothing_01.cc
tests/hp/fe_nothing_02.cc
tests/hp/fe_nothing_03.cc
tests/hp/fe_nothing_05.cc
tests/hp/fe_nothing_06.cc
tests/hp/fe_nothing_07.cc
tests/hp/fe_nothing_08.cc
tests/hp/fe_nothing_09.cc
tests/hp/fe_nothing_11.cc
tests/hp/fe_nothing_15.cc
tests/hp/fe_nothing_16.cc
tests/hp/fe_nothing_18.cc
tests/hp/fe_nothing_20.cc
tests/hp/fe_nothing_21.cc
tests/hp/hp_constraints_neither_dominate_01.cc
tests/hp/hp_constraints_neither_dominate_02.cc
tests/hp/hp_hanging_nodes_01.cc
tests/hp/hp_q_hierarchical_constraints.cc
tests/hp/interpolate_nothing_03.cc
tests/hp/n_active_fe_indices.cc
tests/hp/n_boundary_dofs_01.cc
tests/hp/p_adaptivity_absolute_threshold.cc
tests/hp/p_adaptivity_fixed_number.cc
tests/hp/p_adaptivity_flags.cc
tests/hp/p_adaptivity_full.cc
tests/hp/p_adaptivity_reference.cc
tests/hp/p_adaptivity_regularity.cc
tests/hp/p_adaptivity_relative_threshold.cc
tests/hp/project_01.cc
tests/hp/project_01_curved_boundary.cc
tests/hp/project_02.cc
tests/hp/q_vs_dgq.cc
tests/hp/renumber_block_wise_02.cc
tests/hp/renumber_component_wise.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_13.cc
tests/hp/solution_transfer_15.cc
tests/hp/solution_transfer_16.cc
tests/hp/step-10.cc
tests/hp/step-12.cc
tests/hp/step-13.cc
tests/hp/step-2.cc
tests/hp/step-27.cc
tests/hp/step-7.cc
tests/integrators/advection_01.cc
tests/integrators/assembler_simple_matrix_01.cc
tests/integrators/assembler_simple_matrix_01m.cc
tests/integrators/assembler_simple_matrix_02.cc
tests/integrators/assembler_simple_matrix_02m.cc
tests/integrators/assembler_simple_matrix_03.cc
tests/integrators/assembler_simple_matrix_03m.cc
tests/integrators/assembler_simple_matrix_03tri.cc
tests/integrators/assembler_simple_matrix_04.cc
tests/integrators/assembler_simple_mgmatrix_01.cc
tests/integrators/assembler_simple_mgmatrix_02.cc
tests/integrators/assembler_simple_mgmatrix_03.cc
tests/integrators/assembler_simple_mgmatrix_04.cc
tests/integrators/assembler_simple_system_inhom_01.cc
tests/integrators/cells_and_faces_01.cc
tests/integrators/cochain_01.cc
tests/integrators/divergence_01.cc
tests/integrators/elasticity_01.cc
tests/integrators/elasticity_02.cc
tests/integrators/functional_01.cc
tests/integrators/grad_div_01.cc
tests/integrators/laplacian_01.cc
tests/integrators/laplacian_02.cc
tests/integrators/maxwell_curl.cc
tests/integrators/mesh_worker_01.cc
tests/integrators/mesh_worker_02.cc
tests/integrators/mesh_worker_03.cc
tests/integrators/mesh_worker_1d_dg.cc
tests/integrators/mesh_worker_matrix_01.cc
tests/lac/bicgstab_early.cc
tests/lac/bicgstab_large.cc
tests/lac/block_linear_operator_01.cc
tests/lac/block_linear_operator_02.cc
tests/lac/block_linear_operator_03.cc
tests/lac/block_linear_operator_04.cc
tests/lac/block_linear_operator_05.cc
tests/lac/block_linear_operator_06.cc
tests/lac/block_matrices_04.cc
tests/lac/block_minres.cc
tests/lac/block_vector_iterator.cc
tests/lac/block_vector_move_operations.cc
tests/lac/block_vector_vector_assign.cc
tests/lac/complex_block_vector_iterator.cc
tests/lac/complex_block_vector_vector_assign.cc
tests/lac/constrained_linear_operator_01.cc
tests/lac/constraint_graph_zero.cc
tests/lac/constraint_matrix_copy_01.cc
tests/lac/constraint_matrix_distribute_complex.cc
tests/lac/constraint_matrix_distribute_local_global.cc
tests/lac/constraints_01.cc
tests/lac/constraints_02.cc
tests/lac/constraints_block_01.cc
tests/lac/constraints_c1.cc
tests/lac/constraints_c1_02.cc
tests/lac/constraints_inhomogeneous.cc
tests/lac/constraints_move.cc
tests/lac/constraints_shift_01.cc
tests/lac/constraints_zero.cc
tests/lac/constraints_zero_condense.cc
tests/lac/constraints_zero_merge.cc
tests/lac/copy_transposed.cc
tests/lac/diagonal_matrix_02.cc
tests/lac/eigen.cc
tests/lac/gmres_eigenvalues.cc
tests/lac/gmres_reorthogonalize_02.cc
tests/lac/gmres_reorthogonalize_03.cc
tests/lac/gmres_reorthogonalize_04.cc
tests/lac/gmres_reorthogonalize_05.cc
tests/lac/householder.cc
tests/lac/identity_matrix_01.cc
tests/lac/identity_matrix_02.cc
tests/lac/identity_matrix_03.cc
tests/lac/identity_matrix_04.cc
tests/lac/identity_matrix_05.cc
tests/lac/identity_matrix_06.cc
tests/lac/inhomogeneous_constraints.cc
tests/lac/inhomogeneous_constraints_02.cc
tests/lac/inhomogeneous_constraints_03.cc
tests/lac/inhomogeneous_constraints_04.cc
tests/lac/inhomogeneous_constraints_block.cc
tests/lac/inhomogeneous_constraints_nonsymmetric.cc
tests/lac/inhomogeneous_constraints_vector.cc
tests/lac/la_parallel_vector_add_and_dot_complex.cc
tests/lac/la_vector_add_and_dot.cc
tests/lac/la_vector_add_and_dot_complex.cc
tests/lac/linear_operator_01.cc
tests/lac/linear_operator_01a.cc
tests/lac/linear_operator_01b.cc
tests/lac/linear_operator_01c.cc
tests/lac/linear_operator_01d.cc
tests/lac/linear_operator_02.cc
tests/lac/linear_operator_02a.cc
tests/lac/linear_operator_03.cc
tests/lac/linear_operator_04.cc
tests/lac/linear_operator_04a.cc
tests/lac/linear_operator_05.cc
tests/lac/linear_operator_06.cc
tests/lac/linear_operator_07.cc
tests/lac/linear_operator_08.cc
tests/lac/linear_operator_09.cc
tests/lac/linear_operator_10.cc
tests/lac/linear_operator_10a.cc
tests/lac/linear_operator_12.cc
tests/lac/linear_operator_12a.cc
tests/lac/linear_operator_13.cc
tests/lac/linear_operator_14.cc
tests/lac/linear_operator_15.cc
tests/lac/linear_operator_16.cc
tests/lac/linear_operator_17.cc
tests/lac/linear_operator_17a.cc
tests/lac/linear_operator_18.cc
tests/lac/matrices.cc
tests/lac/matrices_ez.cc
tests/lac/matrices_ez_add.cc
tests/lac/matrices_lapack.cc
tests/lac/matrices_lapack_fill.cc
tests/lac/packaged_operation_01.cc
tests/lac/packaged_operation_01a.cc
tests/lac/packaged_operation_02.cc
tests/lac/precondition_chebyshev_02.cc
tests/lac/precondition_chebyshev_03.cc
tests/lac/precondition_chebyshev_04.cc
tests/lac/precondition_chebyshev_05.cc
tests/lac/print_formatted_ez_01.cc
tests/lac/schur_complement_01.cc
tests/lac/schur_complement_02.cc
tests/lac/schur_complement_03.cc
tests/lac/schur_complement_04.cc
tests/lac/solver.cc
tests/lac/solver_02.cc
tests/lac/solver_control_01.cc
tests/lac/solver_control_02.cc
tests/lac/solver_control_03.cc
tests/lac/solver_control_04.cc
tests/lac/solver_control_05.cc
tests/lac/solver_control_06.cc
tests/lac/solver_fire_01.cc
tests/lac/solver_fire_rosenbrock_01.cc
tests/lac/solver_memorytest.cc
tests/lac/solver_monitor.cc
tests/lac/solver_monitor_disconnect.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_02.cc
tests/lac/solver_selector_03.cc
tests/lac/solver_signals.cc
tests/lac/sparse_ilu.cc
tests/lac/sparse_ilu_inverse.cc
tests/lac/sparse_ilu_t.cc
tests/lac/sparse_matrices.cc
tests/lac/sparse_matrix_move.cc
tests/lac/sparse_mic.cc
tests/lac/tensor_product_matrix_01.cc
tests/lac/tensor_product_matrix_02.cc
tests/lac/tensor_product_matrix_03.cc
tests/lac/tensor_product_matrix_04.cc
tests/lac/tensor_product_matrix_05.cc
tests/lac/tensor_product_matrix_06.cc
tests/lac/tensor_product_matrix_vectorized_01.cc
tests/lac/tensor_product_matrix_vectorized_02.cc
tests/lac/tensor_product_matrix_vectorized_03.cc
tests/lac/tensor_product_matrix_vectorized_04.cc
tests/lac/utilities_01.cc
tests/lac/utilities_02.cc
tests/lac/utilities_03.cc
tests/lac/utilities_04.cc
tests/lac/utilities_05.cc
tests/lac/vector-vector.cc
tests/lac/vector_accumulation_02.cc
tests/lac/vector_add_and_dot.cc
tests/lac/vector_add_and_dot_complex.cc
tests/lac/vector_memory.cc
tests/lac/vector_move_operations.cc
tests/lapack/full_matrix_02.cc
tests/lapack/full_matrix_12.cc
tests/lapack/full_matrix_14.cc
tests/lapack/full_matrix_15.cc
tests/lapack/full_matrix_16.cc
tests/lapack/full_matrix_17.cc
tests/lapack/full_matrix_18.cc
tests/lapack/full_matrix_19.cc
tests/lapack/full_matrix_20.cc
tests/lapack/full_matrix_21.cc
tests/lapack/full_matrix_22.cc
tests/lapack/full_matrix_23.cc
tests/lapack/full_matrix_24.cc
tests/lapack/full_matrix_25.cc
tests/lapack/full_matrix_27.cc
tests/lapack/full_matrix_28.cc
tests/lapack/full_matrix_29.cc
tests/lapack/full_matrix_31.cc
tests/lapack/full_matrix_32.cc
tests/lapack/full_matrix_33.cc
tests/lapack/full_matrix_34.cc
tests/lapack/full_matrix_36.cc
tests/lapack/solver_cg.cc
tests/manifold/chart_manifold_02.cc
tests/manifold/chart_manifold_02_embedded.cc
tests/manifold/copy_boundary_to_manifold_id_01.cc
tests/manifold/copy_material_to_manifold_id_01.cc
tests/manifold/elliptical_manifold_02.cc
tests/manifold/flat_manifold_02.cc
tests/manifold/flat_manifold_08.cc
tests/manifold/flat_manifold_09.cc
tests/manifold/manifold_id_01.cc
tests/manifold/manifold_id_02.cc
tests/manifold/manifold_id_03.cc
tests/manifold/manifold_id_04.cc
tests/manifold/manifold_id_05.cc
tests/manifold/manifold_id_06.cc
tests/manifold/manifold_id_07.cc
tests/manifold/map_boundary_to_manifold_id_01.cc
tests/manifold/map_boundary_to_manifold_id_02.cc
tests/manifold/set_all_manifold_ids_01.cc
tests/manifold/set_all_manifold_ids_02.cc
tests/manifold/spherical_manifold_02.cc
tests/manifold/spherical_manifold_04.cc
tests/manifold/spherical_manifold_07.cc
tests/manifold/spherical_manifold_08.cc
tests/manifold/spherical_manifold_09.cc
tests/manifold/spherical_manifold_10.cc
tests/manifold/spherical_manifold_12.cc
tests/manifold/transfinite_manifold_01.cc
tests/manifold/transfinite_manifold_02.cc
tests/manifold/transfinite_manifold_03.cc
tests/manifold/transfinite_manifold_04.cc
tests/manifold/transfinite_manifold_05.cc
tests/manifold/transfinite_manifold_06.cc
tests/manifold/transfinite_manifold_07.cc
tests/manifold/transfinite_manifold_08.cc
tests/manifold/transfinite_manifold_09.cc
tests/manifold/transfinite_manifold_10.cc
tests/manifold/tria_accessor_point_01.cc
tests/manifold/tria_accessor_point_02.cc
tests/manifold/tria_boundary_id_01.cc
tests/mappings/fe_face_values_1d_mapping_cartesian.cc
tests/mappings/fe_face_values_1d_mapping_q2.cc
tests/mappings/mapping.cc
tests/mappings/mapping_c1.cc
tests/mappings/mapping_fe_field_01.cc
tests/mappings/mapping_fe_field_02.cc
tests/mappings/mapping_fe_field_03.cc
tests/mappings/mapping_fe_field_04.cc
tests/mappings/mapping_fe_field_05.cc
tests/mappings/mapping_fe_field_06.cc
tests/mappings/mapping_fe_field_08.cc
tests/mappings/mapping_fe_field_contravariant_01.cc
tests/mappings/mapping_fe_field_real_to_unit_b1.cc
tests/mappings/mapping_fe_field_real_to_unit_b2_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_b2_mask.cc
tests/mappings/mapping_fe_field_real_to_unit_b3_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_b4_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_b5_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q1.cc
tests/mappings/mapping_fe_field_real_to_unit_q2_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q2_mask.cc
tests/mappings/mapping_fe_field_real_to_unit_q3_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q4_curved.cc
tests/mappings/mapping_fe_field_real_to_unit_q5_curved.cc
tests/mappings/mapping_manifold_05.cc
tests/mappings/mapping_manifold_06.cc
tests/mappings/mapping_manifold_07.cc
tests/mappings/mapping_project_01.cc
tests/mappings/mapping_q1_cartesian_grid.cc
tests/mappings/mapping_q1_eulerian_01.cc
tests/mappings/mapping_q_convergence.cc
tests/mappings/mapping_q_eulerian_01.cc
tests/mappings/mapping_q_eulerian_02.cc
tests/mappings/mapping_q_eulerian_03.cc
tests/mappings/mapping_q_eulerian_07.cc
tests/mappings/mapping_q_eulerian_08.cc
tests/mappings/mapping_q_eulerian_09.cc
tests/mappings/mapping_q_eulerian_10.cc
tests/mappings/mapping_q_eulerian_11.cc
tests/mappings/mapping_q_eulerian_12.cc
tests/mappings/mapping_q_eulerian_13.cc
tests/mappings/mapping_q_generic_cell_cache.cc
tests/mappings/mapping_q_manifold_01.cc
tests/mappings/mapping_q_manifold_02.cc
tests/mappings/mapping_q_mixed_manifolds_02.cc
tests/matrix_free/additional_data_copy.cc
tests/matrix_free/advect_1d.cc
tests/matrix_free/advect_1d_system.cc
tests/matrix_free/advect_1d_vectorization_mask.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/cell_categorization.cc
tests/matrix_free/cell_categorization_02.cc
tests/matrix_free/cell_level_and_index.cc
tests/matrix_free/compare_faces_by_cells.cc
tests/matrix_free/compress_constraints.cc
tests/matrix_free/compress_mapping.cc
tests/matrix_free/copy.cc
tests/matrix_free/copy_feevaluation.cc
tests/matrix_free/dg_pbc_01.cc
tests/matrix_free/dg_pbc_02.cc
tests/matrix_free/dof_info_01.cc
tests/matrix_free/dof_info_02.cc
tests/matrix_free/estimate_condition_number_mass.cc
tests/matrix_free/evaluate_1d_shape_07.cc
tests/matrix_free/evaluate_1d_shape_08.cc
tests/matrix_free/evaluate_1d_shape_09.cc
tests/matrix_free/face_setup_01.cc
tests/matrix_free/faces_value_optimization.cc
tests/matrix_free/faces_value_optimization_02.cc
tests/matrix_free/get_functions_cartesian.cc
tests/matrix_free/get_functions_circle.cc
tests/matrix_free/get_functions_common.h
tests/matrix_free/get_functions_constraints.cc
tests/matrix_free/get_functions_faces.cc
tests/matrix_free/get_functions_float.cc
tests/matrix_free/get_functions_gl.cc
tests/matrix_free/get_functions_mappingq.cc
tests/matrix_free/get_functions_multife.cc
tests/matrix_free/get_functions_multife2.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_functions_variants.cc
tests/matrix_free/get_functions_variants_gl.cc
tests/matrix_free/get_values_plain.cc
tests/matrix_free/integrate_functions.cc
tests/matrix_free/integrate_functions_multife.cc
tests/matrix_free/integrate_functions_multife2.cc
tests/matrix_free/interpolate_constant.cc
tests/matrix_free/interpolate_cubic.cc
tests/matrix_free/interpolate_functions_common.h
tests/matrix_free/interpolate_linear.cc
tests/matrix_free/interpolate_quadratic.cc
tests/matrix_free/interpolate_to_mg.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/iterators.cc
tests/matrix_free/jxw_values.cc
tests/matrix_free/laplace_operator_01.cc
tests/matrix_free/laplace_operator_02.cc
tests/matrix_free/mass_operator_01.cc
tests/matrix_free/mass_operator_02.cc
tests/matrix_free/mass_operator_03.cc
tests/matrix_free/matrix_vector_01.cc
tests/matrix_free/matrix_vector_02.cc
tests/matrix_free/matrix_vector_03.cc
tests/matrix_free/matrix_vector_04.cc
tests/matrix_free/matrix_vector_04b.cc
tests/matrix_free/matrix_vector_05.cc
tests/matrix_free/matrix_vector_06.cc
tests/matrix_free/matrix_vector_06_notempl.cc
tests/matrix_free/matrix_vector_07.cc
tests/matrix_free/matrix_vector_08.cc
tests/matrix_free/matrix_vector_09.cc
tests/matrix_free/matrix_vector_10.cc
tests/matrix_free/matrix_vector_11.cc
tests/matrix_free/matrix_vector_12.cc
tests/matrix_free/matrix_vector_13.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_19.cc
tests/matrix_free/matrix_vector_20.cc
tests/matrix_free/matrix_vector_21.cc
tests/matrix_free/matrix_vector_22.cc
tests/matrix_free/matrix_vector_23.cc
tests/matrix_free/matrix_vector_24.cc
tests/matrix_free/matrix_vector_blocks.cc
tests/matrix_free/matrix_vector_common.h
tests/matrix_free/matrix_vector_curl.cc
tests/matrix_free/matrix_vector_div.cc
tests/matrix_free/matrix_vector_faces_01.cc
tests/matrix_free/matrix_vector_faces_02.cc
tests/matrix_free/matrix_vector_faces_03.cc
tests/matrix_free/matrix_vector_faces_04.cc
tests/matrix_free/matrix_vector_faces_05.cc
tests/matrix_free/matrix_vector_faces_06.cc
tests/matrix_free/matrix_vector_faces_07.cc
tests/matrix_free/matrix_vector_faces_08.cc
tests/matrix_free/matrix_vector_faces_09.cc
tests/matrix_free/matrix_vector_faces_10.cc
tests/matrix_free/matrix_vector_faces_11.cc
tests/matrix_free/matrix_vector_faces_12.cc
tests/matrix_free/matrix_vector_faces_13.cc
tests/matrix_free/matrix_vector_faces_14.cc
tests/matrix_free/matrix_vector_faces_15.cc
tests/matrix_free/matrix_vector_faces_16.cc
tests/matrix_free/matrix_vector_faces_17.cc
tests/matrix_free/matrix_vector_faces_18.cc
tests/matrix_free/matrix_vector_faces_19.cc
tests/matrix_free/matrix_vector_faces_20.cc
tests/matrix_free/matrix_vector_faces_21.cc
tests/matrix_free/matrix_vector_faces_22.cc
tests/matrix_free/matrix_vector_faces_23.cc
tests/matrix_free/matrix_vector_faces_24.cc
tests/matrix_free/matrix_vector_faces_25.cc
tests/matrix_free/matrix_vector_faces_26.cc
tests/matrix_free/matrix_vector_faces_28.cc
tests/matrix_free/matrix_vector_faces_common.h
tests/matrix_free/matrix_vector_float.cc
tests/matrix_free/matrix_vector_hp.cc
tests/matrix_free/matrix_vector_large_degree_01.cc
tests/matrix_free/matrix_vector_large_degree_02.cc
tests/matrix_free/matrix_vector_large_degree_03.cc
tests/matrix_free/matrix_vector_mg.cc
tests/matrix_free/matrix_vector_stokes.cc
tests/matrix_free/matrix_vector_stokes_base.cc
tests/matrix_free/matrix_vector_stokes_flux.cc
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/matrix_vector_stokes_qdg0.cc
tests/matrix_free/matrix_vector_stokes_qdg0b.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_02.cc
tests/matrix_free/parallel_multigrid_adaptive_01.cc
tests/matrix_free/parallel_multigrid_adaptive_02.cc
tests/matrix_free/parallel_multigrid_adaptive_03.cc
tests/matrix_free/parallel_multigrid_adaptive_04.cc
tests/matrix_free/parallel_multigrid_adaptive_05.cc
tests/matrix_free/parallel_multigrid_adaptive_06.cc
tests/matrix_free/parallel_multigrid_adaptive_06ref.cc
tests/matrix_free/parallel_multigrid_adaptive_07.cc
tests/matrix_free/parallel_multigrid_adaptive_08.cc
tests/matrix_free/parallel_multigrid_fullydistributed.cc
tests/matrix_free/parallel_multigrid_mf.cc
tests/matrix_free/parallel_multigrid_mf_02.cc
tests/matrix_free/partitioner_01.cc
tests/matrix_free/pre_and_post_loops_01.cc
tests/matrix_free/pre_and_post_loops_02.cc
tests/matrix_free/pre_and_post_loops_03.cc
tests/matrix_free/pre_and_post_loops_04.cc
tests/matrix_free/pre_and_post_loops_05.cc
tests/matrix_free/quadrature_points.cc
tests/matrix_free/read_cell_data_01.cc
tests/matrix_free/read_cell_data_02.cc
tests/matrix_free/shape_info.cc
tests/matrix_free/shape_info_inverse.cc
tests/matrix_free/step-37-inhomogeneous-1.cc
tests/matrix_free/step-37.cc
tests/matrix_free/step-48.cc
tests/matrix_free/step-48b.cc
tests/matrix_free/step-48c.cc
tests/matrix_free/stokes_computation.cc
tests/matrix_free/thread_correctness.cc
tests/matrix_free/thread_correctness_dg.cc
tests/matrix_free/thread_correctness_hp.cc
tests/matrix_free/update_mapping_only.cc
tests/meshworker/codim_01.cc
tests/meshworker/mesh_loop_04.cc
tests/meshworker/mesh_loop_05.cc
tests/meshworker/mesh_loop_06.cc
tests/meshworker/mesh_loop_gmg_01.cc
tests/meshworker/scratch_data_01.cc
tests/meshworker/scratch_data_02.cc
tests/meshworker/scratch_data_03.cc
tests/meshworker/scratch_data_05.cc
tests/meshworker/scratch_data_06.cc
tests/meshworker/scratch_data_07.cc
tests/meshworker/step-11-mesh_loop.cc
tests/meshworker/step-50-mesh_loop.cc
tests/mpi/blockvec_02.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/collective_sparse_matrix_01.cc
tests/mpi/communicate_moved_vertices_03.cc
tests/mpi/compute_index_owner_01.cc
tests/mpi/constraints_consistent_01.cc
tests/mpi/count_dofs_per_block_01.cc
tests/mpi/count_dofs_per_block_02.cc
tests/mpi/count_dofs_per_component_01.cc
tests/mpi/cuthill_mckee_01.cc
tests/mpi/data_out_faces_01.cc
tests/mpi/data_out_hdf5_02.cc
tests/mpi/distort_random_01.cc
tests/mpi/distort_random_02.cc
tests/mpi/distribute_flux_sparsity_pattern.cc
tests/mpi/distribute_sp_01.cc
tests/mpi/distribute_sp_02.cc
tests/mpi/dof_handler_number_cache.cc
tests/mpi/fe_field_function_02.cc
tests/mpi/flux_edge_01.cc
tests/mpi/has_hanging_nodes.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_hanging_node_constraints_01.cc
tests/mpi/hp_step-4.cc
tests/mpi/hp_step-40.cc
tests/mpi/hp_step-40_variable_01.cc
tests/mpi/hp_unify_dof_indices_07.cc
tests/mpi/interpolate_to_different_mesh_01.cc
tests/mpi/interpolate_to_different_mesh_02.cc
tests/mpi/mesh_worker_01.cc
tests/mpi/mesh_worker_02.cc
tests/mpi/mesh_worker_03.cc
tests/mpi/mesh_worker_04.cc
tests/mpi/mesh_worker_05.cc
tests/mpi/mesh_worker_matrix_01.cc
tests/mpi/mg_02.cc
tests/mpi/mg_03.cc
tests/mpi/mg_04.cc
tests/mpi/mg_05.cc
tests/mpi/mg_06.cc
tests/mpi/mg_ghost_dofs_periodic_01.cc
tests/mpi/mg_ghost_dofs_periodic_02.cc
tests/mpi/mg_ghost_dofs_periodic_03.cc
tests/mpi/mg_ghost_dofs_periodic_04.cc
tests/mpi/mg_ghost_dofs_periodic_05.cc
tests/mpi/mg_ghost_dofs_periodic_06.cc
tests/mpi/mg_ghost_dofs_periodic_07.cc
tests/mpi/muelu_periodicity.cc
tests/mpi/multigrid_adaptive.cc
tests/mpi/multigrid_uniform.cc
tests/mpi/p4est_2d_constraintmatrix_04.cc
tests/mpi/p4est_2d_dofhandler_01.cc
tests/mpi/p4est_2d_dofhandler_02.cc
tests/mpi/p4est_2d_dofhandler_03.cc
tests/mpi/p4est_2d_dofhandler_04.cc
tests/mpi/p4est_2d_ghost_01.cc
tests/mpi/p4est_2d_ghost_02.cc
tests/mpi/p4est_2d_renumber_02.cc
tests/mpi/p4est_3d_constraintmatrix_03.cc
tests/mpi/p4est_3d_ghost_01.cc
tests/mpi/p4est_data_out_01.cc
tests/mpi/p4est_get_subdomain_association.cc
tests/mpi/p4est_save_03.cc
tests/mpi/parallel_partitioner_08.cc
tests/mpi/parallel_partitioner_09.cc
tests/mpi/parallel_vector_03a.cc
tests/mpi/parallel_vector_09.cc
tests/mpi/parallel_vector_11.cc
tests/mpi/parallel_vector_16.cc
tests/mpi/parallel_vector_24.cc
tests/mpi/parallel_vector_back_interpolate_02.cc
tests/mpi/parallel_vector_interpolate.cc
tests/mpi/periodic_neighbor_01.cc
tests/mpi/periodicity_01.cc
tests/mpi/periodicity_02.cc
tests/mpi/periodicity_03.cc
tests/mpi/periodicity_04.cc
tests/mpi/periodicity_05.cc
tests/mpi/periodicity_06.cc
tests/mpi/periodicity_07.cc
tests/mpi/petsc_step-27.cc
tests/mpi/project_bv_div_conf.cc
tests/mpi/refine_and_coarsen_fixed_fraction_01.cc
tests/mpi/refine_and_coarsen_fixed_fraction_02.cc
tests/mpi/refine_and_coarsen_fixed_fraction_03.cc
tests/mpi/refine_and_coarsen_fixed_fraction_04.cc
tests/mpi/refine_and_coarsen_fixed_fraction_05.cc
tests/mpi/refine_and_coarsen_fixed_fraction_06.cc
tests/mpi/refine_and_coarsen_fixed_number_01.cc
tests/mpi/refine_and_coarsen_fixed_number_02.cc
tests/mpi/refine_and_coarsen_fixed_number_03.cc
tests/mpi/refine_and_coarsen_fixed_number_04.cc
tests/mpi/refine_and_coarsen_fixed_number_05.cc
tests/mpi/refine_and_coarsen_fixed_number_07.cc
tests/mpi/renumber_cuthill_mckee.cc
tests/mpi/renumber_cuthill_mckee_02.cc
tests/mpi/renumber_cuthill_mckee_03.cc
tests/mpi/renumber_z_order_01.cc
tests/mpi/renumber_z_order_02.cc
tests/mpi/solution_transfer_03.cc
tests/mpi/solution_transfer_05.cc
tests/mpi/step-39-block.cc
tests/mpi/step-39.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/torus.cc
tests/mpi/tria_copy_triangulation.cc
tests/mpi/tria_ghost_owners_01.cc
tests/mpi/tria_ghost_owners_02.cc
tests/mpi/trilinos_step-27.cc
tests/multigrid/boundary_01.cc
tests/multigrid/constrained_dofs_01.cc
tests/multigrid/constrained_dofs_02.cc
tests/multigrid/constrained_dofs_03.cc
tests/multigrid/constrained_dofs_05.cc
tests/multigrid/count_01.cc
tests/multigrid/cycles.cc
tests/multigrid/distribute_bug_01.cc
tests/multigrid/dof_01.cc
tests/multigrid/dof_02.cc
tests/multigrid/dof_03.cc
tests/multigrid/dof_04.cc
tests/multigrid/dof_05.cc
tests/multigrid/events_01.cc
tests/multigrid/interface_matrix_entry_01.cc
tests/multigrid/max_level_for_coarse_mesh.cc
tests/multigrid/mg_coarse_01.cc
tests/multigrid/mg_data_out_01.cc
tests/multigrid/mg_data_out_02.cc
tests/multigrid/mg_data_out_03.cc
tests/multigrid/mg_data_out_04.cc
tests/multigrid/mg_data_out_05.cc
tests/multigrid/mg_output_dirichlet.cc
tests/multigrid/mg_output_neumann.cc
tests/multigrid/mg_renumbered_01.cc
tests/multigrid/mg_renumbered_02.cc
tests/multigrid/mg_renumbered_03.cc
tests/multigrid/renumbering_01.cc
tests/multigrid/renumbering_02.cc
tests/multigrid/renumbering_03.cc
tests/multigrid/renumbering_04.cc
tests/multigrid/step-16-02.cc
tests/multigrid/step-16-03.cc
tests/multigrid/step-16-04.cc
tests/multigrid/step-16-05.cc
tests/multigrid/step-16-06.cc
tests/multigrid/step-16-07.cc
tests/multigrid/step-16-50-mpi-linear-operator.cc
tests/multigrid/step-16-50-mpi-smoother.cc
tests/multigrid/step-16-50-mpi.cc
tests/multigrid/step-16-50-serial.cc
tests/multigrid/step-16-bdry1.cc
tests/multigrid/step-16.cc
tests/multigrid/step-39-02.cc
tests/multigrid/step-39-02a.cc
tests/multigrid/step-39-03.cc
tests/multigrid/step-39.cc
tests/multigrid/step-50_01.cc
tests/multigrid/step-50_02.cc
tests/multigrid/transfer_01.cc
tests/multigrid/transfer_02.cc
tests/multigrid/transfer_03.cc
tests/multigrid/transfer_04.cc
tests/multigrid/transfer_04a.cc
tests/multigrid/transfer_04b.cc
tests/multigrid/transfer_06.cc
tests/multigrid/transfer_block.cc
tests/multigrid/transfer_block_select.cc
tests/multigrid/transfer_compare_01.cc
tests/multigrid/transfer_matrix_free_01.cc
tests/multigrid/transfer_matrix_free_02.cc
tests/multigrid/transfer_matrix_free_02_block.cc
tests/multigrid/transfer_matrix_free_02_block_02.cc
tests/multigrid/transfer_matrix_free_03.cc
tests/multigrid/transfer_matrix_free_04.cc
tests/multigrid/transfer_matrix_free_05.cc
tests/multigrid/transfer_matrix_free_06.cc
tests/multigrid/transfer_matrix_free_07.cc
tests/multigrid/transfer_matrix_free_08.cc
tests/multigrid/transfer_matrix_free_09.cc
tests/multigrid/transfer_matrix_free_10.cc
tests/multigrid/transfer_matrix_free_11.cc
tests/multigrid/transfer_matrix_free_12.cc
tests/multigrid/transfer_matrix_free_13.cc
tests/multigrid/transfer_prebuilt_01.cc
tests/multigrid/transfer_prebuilt_02.cc
tests/multigrid/transfer_prebuilt_03.cc
tests/multigrid/transfer_prebuilt_04.cc
tests/multigrid/transfer_select.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/multigrid/transfer_system_05.cc
tests/multigrid/transfer_system_adaptive_01.cc
tests/multigrid/transfer_system_adaptive_02.cc
tests/multigrid/transfer_system_adaptive_03.cc
tests/multigrid/transfer_system_adaptive_04.cc
tests/multigrid/transfer_system_adaptive_05.cc
tests/multigrid/transfer_system_adaptive_06.cc
tests/multigrid/transfer_system_adaptive_07.cc
tests/multigrid/transfer_system_adaptive_08.cc
tests/multigrid/transfer_system_adaptive_09.cc
tests/multigrid/workload_imbalance.cc
tests/non_matching/coupling_01.cc
tests/non_matching/coupling_02.cc
tests/non_matching/coupling_03.cc
tests/non_matching/coupling_04.cc
tests/non_matching/coupling_05.cc
tests/non_matching/coupling_06.cc
tests/non_matching/coupling_07.cc
tests/non_matching/coupling_08.cc
tests/non_matching/immersed_surface_quadrature.cc
tests/numerics/assemble_matrix_parallel_01.cc
tests/numerics/assemble_matrix_parallel_02.cc
tests/numerics/assemble_matrix_parallel_03.cc
tests/numerics/assemble_matrix_parallel_04.cc
tests/numerics/error_estimator_02.cc
tests/numerics/error_estimator_02_complex.cc
tests/numerics/generalized_interpolation_02.cc
tests/numerics/generalized_interpolation_03.cc
tests/numerics/generalized_interpolation_04.cc
tests/numerics/generalized_interpolation_05.cc
tests/numerics/interpolate_to_different_mesh_01.cc
tests/numerics/interpolate_to_different_mesh_02.cc
tests/numerics/interpolate_to_different_mesh_03.cc
tests/numerics/interpolate_to_different_mesh_04.cc
tests/numerics/kelly_crash_02.cc
tests/numerics/nedelec_projection_mixed_01.cc
tests/numerics/no_flux_01.cc
tests/numerics/no_flux_02.cc
tests/numerics/no_flux_05.cc
tests/numerics/no_flux_08.cc
tests/numerics/no_flux_09.cc
tests/numerics/no_flux_10.cc
tests/numerics/no_flux_11.cc
tests/numerics/no_flux_12.cc
tests/numerics/no_flux_13.cc
tests/numerics/no_flux_14.cc
tests/numerics/no_flux_15.cc
tests/numerics/no_flux_hp_01.cc
tests/numerics/no_flux_hp_02.cc
tests/numerics/no_flux_hp_05.cc
tests/numerics/normal_flux_01.cc
tests/numerics/normal_flux_02.cc
tests/numerics/normal_flux_hp_01.cc
tests/numerics/normal_flux_inhom_01.cc
tests/numerics/point_value_history_01.cc
tests/numerics/point_value_history_02.cc
tests/numerics/point_value_history_03.cc
tests/numerics/project_01.cc
tests/numerics/project_01_curved_boundary.cc
tests/numerics/project_02.cc
tests/numerics/project_03.cc
tests/numerics/project_bv_curl_conf_03.cc
tests/numerics/project_bv_curl_conf_04.cc
tests/numerics/project_bv_curl_conf_complex.cc
tests/numerics/project_bv_div_conf_03.cc
tests/numerics/project_common.h
tests/numerics/project_parallel_qp_common.h
tests/numerics/project_parallel_qp_q_01.cc
tests/numerics/project_parallel_qp_q_02.cc
tests/numerics/project_parallel_qpmf_common.h
tests/numerics/project_parallel_qpmf_q_01.cc
tests/numerics/project_parallel_qpmf_q_02.cc
tests/numerics/project_parallel_qpmf_q_03.cc
tests/numerics/tangential_flux_inhom_01.cc
tests/opencascade/circle_normal_projection.cc
tests/opencascade/iges_describe.cc
tests/opencascade/iges_describe_02.cc
tests/opencascade/interpolation_curve_boundary.cc
tests/opencascade/step_describe.cc
tests/opencascade/step_describe_02.cc
tests/opencascade/stl_creation_single_patch.cc
tests/opencascade/stl_creation_watertight.cc
tests/opencascade/stl_refinement.cc
tests/opencascade/stl_write.cc
tests/optimization/bfgs_03.cc
tests/optimization/bfgs_04.cc
tests/optimization/bfgs_05.cc
tests/optimization/bfgs_05b.cc
tests/optimization/cubic_fit.cc
tests/optimization/cubic_fit_three_points.cc
tests/optimization/line_minimization.cc
tests/optimization/line_minimization_02.cc
tests/optimization/line_minimization_03.cc
tests/optimization/line_minimization_03b.cc
tests/optimization/quadratic_fit.cc
tests/optimization/step-44-with_line_search.cc
tests/optimization/step-44-with_line_search_ptrb.cc
tests/optimization/step-44-without_line_search.cc
tests/optimization/step-44.h
tests/parameter_handler/parameter_handler_25.cc
tests/parameter_handler/parameter_handler_26.cc
tests/parameter_handler/parameter_handler_3_with_sorting_01.cc
tests/parameter_handler/parameter_handler_dos_endings.cc
tests/parameter_handler/parameter_handler_read_json.cc
tests/parameter_handler/parameter_handler_read_xml_error_02.cc
tests/parameter_handler/parameter_handler_read_xml_error_04.cc
tests/parameter_handler/parameter_handler_subsection_exists.cc
tests/parameter_handler/parameter_handler_write_json.cc
tests/parameter_handler/parameter_handler_write_xml.cc
tests/parameter_handler/pattern_tools_01.cc
tests/parameter_handler/pattern_tools_02.cc
tests/parameter_handler/pattern_tools_03.cc
tests/parameter_handler/pattern_tools_04.cc
tests/parameter_handler/pattern_tools_05.cc
tests/parameter_handler/pattern_tools_06.cc
tests/parameter_handler/pattern_tools_07.cc
tests/parameter_handler/patterns_05.cc
tests/parameter_handler/patterns_06.cc
tests/parameter_handler/patterns_07.cc
tests/particles/data_out_01.cc
tests/particles/extract_index_set_01.cc
tests/particles/generators_01.cc
tests/particles/generators_02.cc
tests/particles/generators_03.cc
tests/particles/generators_04.cc
tests/particles/generators_05.cc
tests/particles/generators_06.cc
tests/particles/generators_07.cc
tests/particles/generators_08.cc
tests/particles/generators_09.cc
tests/particles/generators_10.cc
tests/particles/generators_11.cc
tests/particles/generators_12.cc
tests/particles/particle_01.cc
tests/particles/particle_handler_01.cc
tests/particles/particle_handler_02.cc
tests/particles/particle_handler_03.cc
tests/particles/particle_handler_04.cc
tests/particles/particle_handler_05.cc
tests/particles/particle_handler_serial_01.cc
tests/particles/particle_handler_serial_02.cc
tests/particles/particle_handler_serial_03.cc
tests/particles/particle_handler_serial_07.cc
tests/particles/particle_interpolation_01.cc
tests/particles/particle_interpolation_02.cc
tests/particles/particle_interpolation_03.cc
tests/particles/particle_interpolation_04.cc
tests/particles/particle_interpolation_05.cc
tests/particles/set_particle_positions_01.cc
tests/particles/set_particle_positions_02.cc
tests/particles/set_particle_positions_03.cc
tests/petsc/copy_parallel_vector.cc
tests/petsc/deal_solver_01.cc
tests/petsc/deal_solver_02.cc
tests/petsc/deal_solver_03.cc
tests/petsc/deal_solver_04.cc
tests/petsc/deal_solver_05.cc
tests/petsc/different_matrix_preconditioner.cc
tests/petsc/matrix_base_iterator_01.cc
tests/petsc/preconditioner_tvmult_01.cc
tests/petsc/solver_01.cc
tests/petsc/solver_02.cc
tests/petsc/solver_03.cc
tests/petsc/solver_03_mf.cc
tests/petsc/solver_03_precondition_boomeramg.cc
tests/petsc/solver_03_precondition_boomeramg_symmetric.cc
tests/petsc/solver_03_precondition_eisenstat.cc
tests/petsc/solver_03_precondition_icc.cc
tests/petsc/solver_03_precondition_ilu.cc
tests/petsc/solver_03_precondition_lu.cc
tests/petsc/solver_03_precondition_parasails.cc
tests/petsc/solver_03_precondition_sor.cc
tests/petsc/solver_03_precondition_ssor.cc
tests/petsc/solver_04.cc
tests/petsc/solver_05.cc
tests/petsc/solver_06.cc
tests/petsc/solver_07.cc
tests/petsc/solver_08.cc
tests/petsc/solver_09.cc
tests/petsc/solver_10.cc
tests/petsc/solver_11.cc
tests/petsc/solver_12.cc
tests/petsc/solver_13.cc
tests/petsc/sparse_direct_mumps.cc
tests/petsc/update_ghosts.cc
tests/petsc/vector_print.cc
tests/petsc_complex/fe_get_function_values.cc
tests/petsc_complex/parallel_sparse_matrix_01.cc
tests/petsc_complex/solver_real_01.cc
tests/petsc_complex/solver_real_02.cc
tests/petsc_complex/solver_real_03.cc
tests/petsc_complex/solver_real_03_mf.cc
tests/petsc_complex/solver_real_04.cc
tests/physics/elasticity-kinematics_01.cc
tests/physics/elasticity-kinematics_02.cc
tests/physics/elasticity-standard_tensors_01.cc
tests/physics/notation-kelvin_01.cc
tests/physics/notation-kelvin_02.cc
tests/physics/notation-kelvin_03.cc
tests/physics/step-18-rotation_matrix.cc
tests/physics/step-18.cc
tests/physics/step-44-standard_tensors-material_push_forward.cc
tests/physics/step-44-standard_tensors-spatial.cc
tests/physics/step-44.cc
tests/physics/transformations-push_forward_01.cc
tests/physics/transformations-rotations_01.cc
tests/quick_tests/arpack.cc
tests/quick_tests/gsl.cc
tests/quick_tests/p4est.cc
tests/quick_tests/tbb.cc
tests/quick_tests/umfpack.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/sacado/ad_number_traits_01.cc
tests/sacado/ad_number_traits_02_none.cc
tests/sacado/ad_number_traits_02a.cc
tests/sacado/ad_number_traits_02b.cc
tests/sacado/ad_number_traits_02c.cc
tests/sacado/ad_number_traits_02d.cc
tests/sacado/ad_number_traits_03.cc
tests/sacado/helper_scalar_coupled_2_components_01_1.cc
tests/sacado/helper_scalar_coupled_2_components_01_2.cc
tests/sacado/helper_scalar_coupled_2_components_01_3.cc
tests/sacado/helper_scalar_coupled_2_components_01_4.cc
tests/sacado/helper_scalar_coupled_2_components_02_1.cc
tests/sacado/helper_scalar_coupled_2_components_02_2.cc
tests/sacado/helper_scalar_coupled_2_components_02_3.cc
tests/sacado/helper_scalar_coupled_2_components_02_4.cc
tests/sacado/helper_scalar_coupled_2_components_03_1.cc
tests/sacado/helper_scalar_coupled_2_components_03_2.cc
tests/sacado/helper_scalar_coupled_2_components_03_3.cc
tests/sacado/helper_scalar_coupled_2_components_03_4.cc
tests/sacado/helper_scalar_coupled_2_components_04_1.cc
tests/sacado/helper_scalar_coupled_2_components_04_2.cc
tests/sacado/helper_scalar_coupled_2_components_04_3.cc
tests/sacado/helper_scalar_coupled_2_components_04_4.cc
tests/sacado/helper_scalar_coupled_2_components_05_1.cc
tests/sacado/helper_scalar_coupled_2_components_05_2.cc
tests/sacado/helper_scalar_coupled_2_components_05_3.cc
tests/sacado/helper_scalar_coupled_2_components_05_4.cc
tests/sacado/helper_scalar_coupled_2_components_06_1.cc
tests/sacado/helper_scalar_coupled_2_components_06_2.cc
tests/sacado/helper_scalar_coupled_2_components_06_3.cc
tests/sacado/helper_scalar_coupled_2_components_06_4.cc
tests/sacado/helper_scalar_coupled_2_components_07_1.cc
tests/sacado/helper_scalar_coupled_2_components_07_2.cc
tests/sacado/helper_scalar_coupled_2_components_07_3.cc
tests/sacado/helper_scalar_coupled_2_components_07_4.cc
tests/sacado/helper_scalar_coupled_2_components_08_1.cc
tests/sacado/helper_scalar_coupled_2_components_08_2.cc
tests/sacado/helper_scalar_coupled_2_components_08_3.cc
tests/sacado/helper_scalar_coupled_2_components_08_4.cc
tests/sacado/helper_scalar_coupled_3_components_01_1.cc
tests/sacado/helper_scalar_coupled_3_components_01_2.cc
tests/sacado/helper_scalar_coupled_3_components_01_3.cc
tests/sacado/helper_scalar_coupled_3_components_01_4.cc
tests/sacado/helper_scalar_coupled_3_components_01_tapeless_only_1.cc
tests/sacado/helper_scalar_coupled_3_components_01_tapeless_only_2.cc
tests/sacado/helper_scalar_coupled_3_components_01_tapeless_only_3.cc
tests/sacado/helper_scalar_coupled_3_components_01_tapeless_only_4.cc
tests/sacado/helper_scalar_coupled_4_components_01_1.cc
tests/sacado/helper_scalar_coupled_4_components_01_2.cc
tests/sacado/helper_scalar_coupled_4_components_01_3.cc
tests/sacado/helper_scalar_coupled_4_components_01_4.cc
tests/sacado/helper_scalar_single_component_01_1.cc
tests/sacado/helper_scalar_single_component_01_2.cc
tests/sacado/helper_scalar_single_component_01_3.cc
tests/sacado/helper_scalar_single_component_01_4.cc
tests/sacado/helper_scalar_single_component_02_1.cc
tests/sacado/helper_scalar_single_component_02_2.cc
tests/sacado/helper_scalar_single_component_02_3.cc
tests/sacado/helper_scalar_single_component_02_4.cc
tests/sacado/helper_scalar_single_component_03_1.cc
tests/sacado/helper_scalar_single_component_03_2.cc
tests/sacado/helper_scalar_single_component_03_3.cc
tests/sacado/helper_scalar_single_component_03_4.cc
tests/sacado/helper_scalar_single_component_04_1.cc
tests/sacado/helper_scalar_single_component_04_2.cc
tests/sacado/helper_scalar_single_component_04_3.cc
tests/sacado/helper_scalar_single_component_04_4.cc
tests/sacado/helper_vector_1_indep_1_dep_vars_01_1.cc
tests/sacado/helper_vector_1_indep_1_dep_vars_01_2.cc
tests/sacado/helper_vector_1_indep_1_dep_vars_01_3.cc
tests/sacado/helper_vector_1_indep_1_dep_vars_01_4.cc
tests/sacado/helper_vector_1_indep_2_dep_vars_01_1.cc
tests/sacado/helper_vector_1_indep_2_dep_vars_01_2.cc
tests/sacado/helper_vector_1_indep_2_dep_vars_01_3.cc
tests/sacado/helper_vector_1_indep_2_dep_vars_01_4.cc
tests/sacado/helper_vector_2_indep_1_dep_vars_01_1.cc
tests/sacado/helper_vector_2_indep_1_dep_vars_01_2.cc
tests/sacado/helper_vector_2_indep_1_dep_vars_01_3.cc
tests/sacado/helper_vector_2_indep_1_dep_vars_01_4.cc
tests/sacado/helper_vector_2_indep_2_dep_vars_01_1.cc
tests/sacado/helper_vector_2_indep_2_dep_vars_01_2.cc
tests/sacado/helper_vector_2_indep_2_dep_vars_01_3.cc
tests/sacado/helper_vector_2_indep_2_dep_vars_01_4.cc
tests/sacado/physics_functions_01_1.cc
tests/sacado/physics_functions_01_2.cc
tests/sacado/physics_functions_01_3.cc
tests/sacado/physics_functions_01_4.cc
tests/sacado/physics_functions_02_1.cc
tests/sacado/physics_functions_02_2.cc
tests/sacado/physics_functions_02_3.cc
tests/sacado/physics_functions_02_4.cc
tests/sacado/physics_functions_03_1.cc
tests/sacado/physics_functions_03_2.cc
tests/sacado/physics_functions_03_3.cc
tests/sacado/physics_functions_03_4.cc
tests/sacado/step-44-helper_res_lin_01_1.cc
tests/sacado/step-44-helper_res_lin_01_2.cc
tests/sacado/step-44-helper_res_lin_01_3.cc
tests/sacado/step-44-helper_res_lin_01_4.cc
tests/sacado/step-44-helper_scalar_01_1.cc
tests/sacado/step-44-helper_scalar_01_2.cc
tests/sacado/step-44-helper_var_form_01_1.cc
tests/sacado/step-44-helper_var_form_01_2.cc
tests/sacado/step-44-helper_vector_01_1.cc
tests/sacado/step-44-helper_vector_01_2.cc
tests/sacado/step-44-helper_vector_01_3.cc
tests/sacado/step-44-helper_vector_01_4.cc
tests/sacado/symmetric_tensor_functions_01_1.cc
tests/sacado/symmetric_tensor_functions_01_2.cc
tests/sacado/symmetric_tensor_functions_01_3.cc
tests/sacado/symmetric_tensor_functions_01_4.cc
tests/sacado/symmetric_tensor_functions_02_1.cc
tests/sacado/symmetric_tensor_functions_02_2.cc
tests/sacado/symmetric_tensor_functions_02_3.cc
tests/sacado/symmetric_tensor_functions_02_4.cc
tests/sacado/symmetric_tensor_functions_03_1.cc
tests/sacado/symmetric_tensor_functions_03_2.cc
tests/sacado/symmetric_tensor_functions_03_3.cc
tests/sacado/symmetric_tensor_functions_03_4.cc
tests/sacado/symmetric_tensor_functions_04_1.cc
tests/sacado/symmetric_tensor_functions_04_2.cc
tests/sacado/symmetric_tensor_functions_04_3.cc
tests/sacado/symmetric_tensor_functions_04_4.cc
tests/sacado/tensor_functions_01_1.cc
tests/sacado/tensor_functions_01_2.cc
tests/sacado/tensor_functions_01_3.cc
tests/sacado/tensor_functions_01_4.cc
tests/sacado/tensor_functions_02_1.cc
tests/sacado/tensor_functions_02_2.cc
tests/sacado/tensor_functions_02_3.cc
tests/sacado/tensor_functions_02_4.cc
tests/scalapack/scalapack_02.cc
tests/scalapack/scalapack_03.cc
tests/scalapack/scalapack_03_b.cc
tests/scalapack/scalapack_03_c.cc
tests/scalapack/scalapack_04.cc
tests/scalapack/scalapack_04_b.cc
tests/scalapack/scalapack_05.cc
tests/scalapack/scalapack_06.cc
tests/scalapack/scalapack_06a.cc
tests/scalapack/scalapack_06b.cc
tests/scalapack/scalapack_06c.cc
tests/scalapack/scalapack_07.cc
tests/scalapack/scalapack_08.cc
tests/scalapack/scalapack_10.cc
tests/scalapack/scalapack_10_a.cc
tests/scalapack/scalapack_10_b.cc
tests/scalapack/scalapack_10_c.cc
tests/scalapack/scalapack_10_d.cc
tests/scalapack/scalapack_11.cc
tests/scalapack/scalapack_12_a.cc
tests/scalapack/scalapack_12_b.cc
tests/scalapack/scalapack_12_c.cc
tests/scalapack/scalapack_12_d.cc
tests/scalapack/scalapack_13_a.cc
tests/scalapack/scalapack_13_b.cc
tests/scalapack/scalapack_14_a.cc
tests/scalapack/scalapack_14_b.cc
tests/scalapack/scalapack_15.cc
tests/scalapack/scalapack_15_a.cc
tests/scalapack/scalapack_16.cc
tests/scalapack/scalapack_16_a.cc
tests/scalapack/scalapack_17_a.cc
tests/scalapack/scalapack_17_b.cc
tests/serialization/cell_data_1.cc
tests/serialization/dof_handler_01.cc
tests/serialization/fe_series_01.cc
tests/serialization/fe_series_02.cc
tests/serialization/hp_dof_handler_01.cc
tests/serialization/parallel_fullydistributed_construction_data_1.cc
tests/serialization/tensor.cc
tests/serialization/tensor_base_scalar.cc
tests/serialization/triangulation_01.cc
tests/serialization/triangulation_02.cc
tests/sharedtria/dof_01.cc
tests/sharedtria/dof_02.cc
tests/sharedtria/dof_03.cc
tests/sharedtria/dof_04.cc
tests/sharedtria/dof_05.cc
tests/sharedtria/dof_06.cc
tests/sharedtria/hp_dof_01.cc
tests/sharedtria/hp_dof_02.cc
tests/sharedtria/hp_dof_03.cc
tests/sharedtria/hp_dof_04.cc
tests/sharedtria/hp_no_cells_01.cc
tests/sharedtria/mg_dof_02.cc
tests/sharedtria/no_cells_01.cc
tests/sharedtria/tria_custom_refine02.cc
tests/slepc/solve_01.cc
tests/slepc/solve_04.cc
tests/sparsity/block_dynamic_01.cc
tests/sparsity/block_dynamic_sparsity_pattern_indexset_01.cc
tests/sparsity/block_sparsity_pattern_01.cc
tests/sparsity/block_sparsity_pattern_02.cc
tests/sparsity/chunk_sparsity_pattern_01.cc
tests/sparsity/chunk_sparsity_pattern_02.cc
tests/sparsity/chunk_sparsity_pattern_03.cc
tests/sparsity/chunk_sparsity_pattern_04.cc
tests/sparsity/chunk_sparsity_pattern_05.cc
tests/sparsity/chunk_sparsity_pattern_06.cc
tests/sparsity/chunk_sparsity_pattern_07.cc
tests/sparsity/chunk_sparsity_pattern_09.cc
tests/sparsity/chunk_sparsity_pattern_10.cc
tests/sparsity/chunk_sparsity_pattern_11.cc
tests/sparsity/dynamic_sparsity_pattern_10.cc
tests/sparsity/dynamic_sparsity_pattern_11.cc
tests/sparsity/dynamic_sparsity_pattern_12.cc
tests/sparsity/dynamic_sparsity_pattern_13.cc
tests/sparsity/dynamic_sparsity_pattern_14.cc
tests/sparsity/dynamic_sparsity_pattern_15.cc
tests/sparsity/dynamic_sparsity_pattern_16.cc
tests/sparsity/dynamic_sparsity_pattern_19.cc
tests/sparsity/dynamic_sparsity_pattern_index_set_01.cc
tests/sparsity/dynamic_sparsity_pattern_index_set_02.cc
tests/sparsity/sparsity_pattern.cc
tests/sparsity/sparsity_pattern_01.cc
tests/sparsity/sparsity_pattern_02.cc
tests/sparsity/sparsity_pattern_03.cc
tests/sparsity/sparsity_pattern_04.cc
tests/sparsity/sparsity_pattern_05.cc
tests/sparsity/sparsity_pattern_06.cc
tests/sparsity/sparsity_pattern_07.cc
tests/sparsity/sparsity_pattern_09.cc
tests/sparsity/sparsity_pattern_10.cc
tests/sparsity/sparsity_pattern_11.cc
tests/sparsity/sparsity_pattern_12.cc
tests/sparsity/sparsity_pattern_13.cc
tests/sparsity/sparsity_pattern_common.h
tests/sparsity/sparsity_pattern_copy_from_01.cc
tests/sparsity/sparsity_pattern_copy_from_02.cc
tests/sparsity/sparsity_tools_01.cc
tests/sparsity/sparsity_tools_02.cc
tests/sundials/kinsol_01.cc
tests/symengine/basic_01.cc
tests/symengine/basic_02.cc
tests/symengine/basic_03.cc
tests/symengine/basic_04.cc
tests/symengine/basic_05.cc
tests/symengine/basic_06.cc
tests/symengine/basic_07.cc
tests/symengine/substitution_maps_cyclic_dependencies_01.cc
tests/symengine/substitution_maps_cyclic_dependencies_02.cc
tests/symengine/substitution_maps_scalar_01.cc
tests/symengine/substitution_maps_scalar_02.cc
tests/symengine/substitution_maps_scalar_03.cc
tests/symengine/substitution_maps_scalar_04.cc
tests/symengine/substitution_maps_scalar_05.cc
tests/symengine/substitution_maps_tensor_01.cc
tests/symengine/substitution_maps_tensor_02.cc
tests/symengine/substitution_maps_tensor_03.cc
tests/symengine/substitution_maps_tensor_04.cc
tests/symengine/symengine_number_type_01.cc
tests/symengine/symengine_number_type_02.cc
tests/symengine/symengine_number_type_03.cc
tests/symengine/symengine_scalar_operations_01.cc
tests/symengine/symengine_scalar_operations_02.cc
tests/symengine/symengine_scalar_operations_03.cc
tests/symengine/symengine_scalar_operations_04.cc
tests/symengine/symengine_tensor_operations_01.cc
tests/symengine/symengine_tensor_operations_02.cc
tests/symengine/symengine_tensor_operations_03.cc
tests/symengine/symengine_tensor_operations_04.cc
tests/symengine/symengine_utilities_01.cc
tests/tensors/constexpr_tensor.cc
tests/tensors/project_orthogonal.cc
tests/tensors/symmetric_tensor_01.cc
tests/tensors/symmetric_tensor_02.cc
tests/tensors/symmetric_tensor_03.cc
tests/tensors/symmetric_tensor_04.cc
tests/tensors/symmetric_tensor_05.cc
tests/tensors/symmetric_tensor_06.cc
tests/tensors/symmetric_tensor_07.cc
tests/tensors/symmetric_tensor_08.cc
tests/tensors/symmetric_tensor_09.cc
tests/tensors/symmetric_tensor_10.cc
tests/tensors/symmetric_tensor_11.cc
tests/tensors/symmetric_tensor_12.cc
tests/tensors/symmetric_tensor_13.cc
tests/tensors/symmetric_tensor_14.cc
tests/tensors/symmetric_tensor_15.cc
tests/tensors/symmetric_tensor_16.cc
tests/tensors/symmetric_tensor_17.cc
tests/tensors/symmetric_tensor_18.cc
tests/tensors/symmetric_tensor_19.cc
tests/tensors/symmetric_tensor_20.cc
tests/tensors/symmetric_tensor_21.cc
tests/tensors/symmetric_tensor_22.cc
tests/tensors/symmetric_tensor_23.cc
tests/tensors/symmetric_tensor_24.cc
tests/tensors/symmetric_tensor_25.cc
tests/tensors/symmetric_tensor_26.cc
tests/tensors/symmetric_tensor_27.cc
tests/tensors/symmetric_tensor_28.cc
tests/tensors/symmetric_tensor_29.cc
tests/tensors/symmetric_tensor_30.cc
tests/tensors/symmetric_tensor_32.cc
tests/tensors/symmetric_tensor_33.cc
tests/tensors/symmetric_tensor_34.cc
tests/tensors/symmetric_tensor_35.cc
tests/tensors/symmetric_tensor_36.cc
tests/tensors/symmetric_tensor_37.cc
tests/tensors/symmetric_tensor_38.cc
tests/tensors/symmetric_tensor_39.cc
tests/tensors/symmetric_tensor_40.cc
tests/tensors/tensor.cc
tests/tensors/tensor_02.cc
tests/tensors/tensor_03.cc
tests/tensors/tensor_04.cc
tests/tensors/tensor_05.cc
tests/tensors/tensor_06.cc
tests/tensors/tensor_07.cc
tests/tensors/tensor_08.cc
tests/tensors/tensor_09.cc
tests/tensors/tensor_24.cc
tests/tensors/tensor_25.cc
tests/tensors/tensor_26.cc
tests/tensors/tensor_27.cc
tests/tensors/tensor_28.cc
tests/tensors/tensor_30.cc
tests/tensors/tensor_complex.cc
tests/tensors/tensor_complex_02.cc
tests/tensors/tensor_complex_06.cc
tests/tensors/tensor_float.cc
tests/tensors/tensor_nondefault_constructor.cc
tests/tests.h
tests/trilinos/64.cc
tests/trilinos/assemble_matrix_parallel_01.cc
tests/trilinos/assemble_matrix_parallel_02.cc
tests/trilinos/assemble_matrix_parallel_03.cc
tests/trilinos/assemble_matrix_parallel_04.cc
tests/trilinos/assemble_matrix_parallel_05.cc
tests/trilinos/assemble_matrix_parallel_06.cc
tests/trilinos/assemble_matrix_parallel_07.cc
tests/trilinos/deal_solver_01.cc
tests/trilinos/deal_solver_02.cc
tests/trilinos/deal_solver_03.cc
tests/trilinos/deal_solver_04.cc
tests/trilinos/deal_solver_05.cc
tests/trilinos/deal_solver_06.cc
tests/trilinos/direct_solver_2.cc
tests/trilinos/direct_solver_3.cc
tests/trilinos/elide_zeros.cc
tests/trilinos/mg_transfer_prebuilt_01.cc
tests/trilinos/parallel_sparse_matrix_01.cc
tests/trilinos/precondition.cc
tests/trilinos/precondition_amg_dgp_01.cc
tests/trilinos/precondition_amg_dgp_03.cc
tests/trilinos/precondition_muelu_dgp.cc
tests/trilinos/renumbering_01.cc
tests/trilinos/solver_03.cc
tests/trilinos/solver_05.cc
tests/trilinos/solver_07.cc
tests/trilinos/solver_control_01.cc
tests/trilinos/solver_control_02.cc
tests/trilinos/solver_control_03.cc
tests/trilinos/solver_control_04.cc
tests/trilinos/solver_control_05.cc
tests/trilinos/solver_control_06.cc
tests/trilinos/sparse_matrix_02.cc
tests/trilinos/sparse_matrix_03.cc
tests/trilinos/sparse_matrix_04.cc
tests/trilinos/sparse_matrix_05.cc
tests/trilinos/sparse_matrix_07.cc
tests/trilinos/sparse_matrix_07_rectangle.cc
tests/trilinos/sparse_matrix_copy_from_01.cc
tests/trilinos/sparse_matrix_set_03.cc
tests/trilinos/sparsity_pattern_01.cc
tests/trilinos/sparsity_pattern_02.cc
tests/trilinos/sparsity_pattern_03.cc
tests/trilinos/sparsity_pattern_common.h
tests/trilinos/subtract_mean_value_04.cc
tests/trilinos/trilinos_sparsity_pattern_02.cc
tests/trilinos/trilinos_sparsity_pattern_03.cc
tests/trilinos/trilinos_sparsity_pattern_04.cc
tests/trilinos/update_ghosts.cc
tests/trilinos/vector_reinit.cc
tests/trilinos/vector_reinit_to_linear_map.cc
tests/umfpack/umfpack_03.cc
tests/umfpack/umfpack_03_complex.cc
tests/umfpack/umfpack_03_complex_complex.cc
tests/umfpack/umfpack_04.cc
tests/umfpack/umfpack_09.cc
tests/umfpack/umfpack_09_complex.cc
tests/umfpack/umfpack_09_complex_complex_complex_nonblock.cc
tests/vector_tools/integrate_difference_01.cc
tests/vector_tools/integrate_difference_01_complex_01.cc
tests/vector_tools/integrate_difference_01_complex_02.cc
tests/vector_tools/integrate_difference_01_complex_03.cc
tests/vector_tools/integrate_difference_01_complex_04.cc
tests/vector_tools/integrate_difference_02.cc
tests/vector_tools/integrate_difference_02_nan.cc
tests/vector_tools/integrate_difference_03.cc
tests/vector_tools/integrate_difference_04.cc
tests/vector_tools/integrate_difference_04_hp.cc
tests/vector_tools/integrate_difference_04_hp_02.cc
tests/vector_tools/integrate_difference_05.cc
tests/vector_tools/interpolate_with_material_id_01.cc
tests/vector_tools/interpolate_with_material_id_02.cc
tests/zoltan/tria_zoltan_01.cc

index 6098719428432a7fc8dbaf6debf6e34ea3532a7d..ab24b8f477cedbd7bd15d6f3c3fe55be22d15b31 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 7162b575b5c62a7f249ebc5f426a56df709f65f1..1d3adeed6336a3f176e59d966e300f21ca8f38f9 100644 (file)
@@ -1,7 +1,7 @@
 ## ---------------------------------------------------------------------
 ## $Id$
 ##
-## Copyright (C) 2013 - 2017 by the deal.II authors
+## Copyright (C) 2013 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index bb77b0731c120efc4a92f376b3efa5169a1d7c20..e987a0f76bb519f3774d1330930b1be7136bd568 100644 (file)
@@ -1,7 +1,7 @@
 ## ---------------------------------------------------------------------
 ## $Id$
 ##
-## Copyright (C) 2012 - 2016 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 4156575924499e9ff0f8e36888e8715eb5c648d4..90ba0444ff7a854de8d10aaf8b92e91868e41d3f 100644 (file)
@@ -1,7 +1,7 @@
 ## ---------------------------------------------------------------------
 ## $Id$
 ##
-## Copyright (C) 2014 - 2016 by the deal.II authors
+## Copyright (C) 2014 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 8aa712f14bf73d8ee5ea37a914a888c26615c6ba..f81d1bcd4a5abc615447a6fb3d804b61d5baf2e0 100644 (file)
@@ -1,7 +1,7 @@
 ## ---------------------------------------------------------------------
 ## $Id$
 ##
-## Copyright (C) 2012 - 2016 by the deal.II authors
+## Copyright (C) 2012 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 308d6ebcddfbe7373e79ce9aa1ac14b47f5aeebb..f9c069292258e0f3607b9b1e90e338463fb2ad08 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2018 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index bca065262ca2b281c33bee800ee1ff84ff34fde4..da43159398e491bd452db7903398004d5bddf59d 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2018 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 8623ff3d15762522e7967a2718615c1d97c861fd..182d9469712672bd2c767fd038c9743cbb32123a 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index cc22fec6b5728e037a616bdf4637d460d0dbc491..187b20e20c4ce00cdcc901d04129ba09a1597c43 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 4b599362ab58acac680ba578ba83892f93257995..435f455f1cbd2b403a4a5dc992d0071222b2e073 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index fc9bfa923ffa2b94338a4ea08194811f2d9ab345..48746a32098610c1db5a9ee0164aa899a3b600a2 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2018 by the deal.II authors
+## Copyright (C) 2012 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index b0199db51a8e9ae7f40c2f27566e5cd3943c7e2e..85d0b3da9b845c24e7504c30268becdb1ba76b7e 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2018 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 2df87f7442eac9ce006c2e5374369921c28586a8..2bbdcc0f715ac40e038b7411559bb8d5f887880e 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index f33ad4b1665ffe8e86a714440bf59c237eaa393a..aa22c462147ffde68bb64f4997d19049430a651d 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2017 - 2018 by the deal.II authors
+## Copyright (C) 2017 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index bf640d5c7982ed78a8e687b28aadbf548520f66b..750b3976ef384a8965c3a1580de3f845dbdb1aba 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2019-2020 by the deal.II authors
+## Copyright (C) 2019 - 2020-2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index b0c6a78cc4953e608da003e55286cbdbf8a29510..eafb3329d2d2e972b010c1b675f58083682a1e10 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2019 by the deal.II authors
+## Copyright (C) 2019 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 9b3c878a85ddccbf30a6e3f65391d4753444122b..42dea34149e66a5c49beaace23e15ecea5de7c69 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2013 - 2018 by the deal.II authors
+## Copyright (C) 2013 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index ad1727141412e175179f813832a60fa6d9315e91..3db9b0ca8b8524907c0dae31ae6a0aa901c38176 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2013 - 2018 by the deal.II authors
+## Copyright (C) 2013 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 20f300da931f020df418997d1c4a37f8fdaf3899..d6446b95f32a5654e9260126ca2b71f5f21c60fb 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2018 by the deal.II authors
+## Copyright (C) 2012 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 0c2917817cc1dcae9330f52d93fff0bb835bcb22..66fe7357ba6406e1f76a4a3aae8b1b7339e8a825 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2018 - 2019 by the deal.II authors
+## Copyright (C) 2018 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 33c9b83d1d45fa9193fa3700b0eb8ec7559d6043..ebc3b99cb1f798bcbf8edb1ae44ed9382bb99dc9 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2014 by the deal.II authors
+## Copyright (C) 2012 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 547301bb2db78faa23a9602a021959dd34ea2fd8..88600e0f204f6178126db6a1452b56aa930a95d7 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2018 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 6dc45c7939c3a1d2825a0ddfd0a7bb8308efa912..a60d25882d455b4c8b979fd59deeeab0bf5904dc 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2018 by the deal.II authors
+## Copyright (C) 2012 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 9e71ac6d38d4387aa73a7e2516de881e227bb363..36c710d504caa71ffe8fe27d56df9670f5cb9298 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2014 - 2018 by the deal.II authors
+## Copyright (C) 2014 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index e29c34c99f0657972c4d28d1e7ff10d65c1fbef7..4e04ee2bde4d906dea5667fc291e55dcccf4052f 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2016 by the deal.II authors
+## Copyright (C) 2016 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index a1338d6464eddc2845c4e1c6e824cad542209e79..40d43155b8d18d269163721b90849ece8cbe3e03 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc7838ecc648488f5f281d14487cfeeb0dac9bec..8cbc3d624c1bdf47add54dcfb127ac2e4783133b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d3316f88237608ea2da0eacac603426a23b060c..d25fd316d1606ef168036bdab98db6ea3c709f46 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10b818544963bd3d786b8e76a73b15d37d87f2b9..8780bd0bc2e9cd2407bdba31c39d46496bb0a300 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 025521a86827f56ffe8efb229418846542d0ac3f..874cc388539b1753599c67cc5f326326b12075ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cb4b226866f45f4c3d8957febc2cebb23de1a16..5e56282e72f6907e87d0cf765388c6d222284190 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b6277e5dc3e32d57277300348affca99ab75924..7107d54c0c586a9f4e2246bd8d5393b19905307b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3127672b2bf5880fd8342ef5b207abc0cd5549c9..c6ab09562fe2a51fde8ad1777da01882805c6684 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2016 - 2018 by the deal.II authors
+## Copyright (C) 2016 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 1d5f841bdd53412674ea2e4e344309f6835290e2..7470d5da09b3f5944485556bb4d914e3f3e719c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bdb51b196b0572faa182e3ec670580db8622d19e..67f6ff59e0fa365ac61437b4bd547e29fa8fd78c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dda1220f9579aedc440927d7d65747903482d142..4dbde41273cadc938c62ed51aa500fdd44bedb09 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1a8a3fb5ec57766891e200f94870bcd18e5316a..b5a970200e58a9e7dd8b6a4ac44033dceed8ddd5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 973ea40380bbae6d6051c516e74d8414af3b16e9..78c83ef75631206765fe9ef9ae4e50704c650112 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cfad93f265bd52104895156cea87e9b802c1c012..af6755d8c812cac11ca9d77a948153dfece59798 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 958f720c861f65eac5d623096abf4a9e82563f70..675971c6324b1810a607a069194b7d4ad9f6ec65 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5a601215bb9310c11583346f4f13b1c372b7eaf..4f32779f20ce7779701022381197014f60d2571a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 973dcc230801eeaf0c4057b034db6ea269006ac1..7bc1a441962bde4d7202bdb0539bdb8bbd125251 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b573d4c9707a78761999f9999774fa78224db43a..f846d216301529c4408c96ca7c106b09d06faab4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b96f5181b3a54a5e607c5b02c024842a95afcc77..8d895835dd9072caff5313496871d109ee7e1788 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d0fe321fdb134326acb4bbda65640ff783730f6..2c0aaa17927c7ed28d10e688d959c77015c9484a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf80661dfa6ebb708cfc3333bfa6ac01cb631d88..526d3fdc6d9454286dd23e9d22128e9a056c1805 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e07bda593b5dae1ca2380f5078879f7bd11872fc..2e32c15b40aef270c485b8e8f20fc25d58f95f06 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5eb2db61ebcef65b111cf9875ccc00698a78fbb8..05d0885fd1ea535e5c001788fb578d34da361720 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2017 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 662208ccc4353a7e82d729beee2d97ffe547aa91..826170380f666388fb3289dd176d1ea44c2d60dc 100644 (file)
@@ -1,6 +1,6 @@
 # ---------------------------------------------------------------------
 #
-# Copyright (C) 2016 by the deal.II authors
+# Copyright (C) 2016 - 2019 by the deal.II authors
 #
 # This file is part of the deal.II library.
 #
index f4330bd2adb7316c7e54e70d274ffa8fcc682d33..b595ff39ec3b43296a6e0f8e7c7d28981cc5cd08 100644 (file)
@@ -1,6 +1,6 @@
 # ---------------------------------------------------------------------
 #
-# Copyright (C) 2016 by the deal.II authors
+# Copyright (C) 2016 - 2020 by the deal.II authors
 #
 # This file is part of the deal.II library.
 #
index b264e7bac56b39a602bb780bc96d90a7dec4603a..78b181f82d9d5415c423f9cda0f8897a8d8f38f1 100644 (file)
@@ -1,6 +1,6 @@
 # ---------------------------------------------------------------------
 #
-# Copyright (C) 2016 by the deal.II authors
+# Copyright (C) 2016 - 2019 by the deal.II authors
 #
 # This file is part of the deal.II library.
 #
index 2a7cb286279f53c0733a0e6daad4832d6793baf8..258f6b00d5e0cf2c4ef493543b0812132bffde5b 100644 (file)
@@ -1,6 +1,6 @@
 # ---------------------------------------------------------------------
 #
-# Copyright (C) 2016 by the deal.II authors
+# Copyright (C) 2016 - 2020 by the deal.II authors
 #
 # This file is part of the deal.II library.
 #
index bd13b682a6788b43184cd9154658f873754db03c..4cb19f8e25311cd3bdb9552667ef3803eedb2fd4 100644 (file)
@@ -1,6 +1,6 @@
 # ---------------------------------------------------------------------
 #
-# Copyright (C) 2016 - 2017 by the deal.II authors
+# Copyright (C) 2016 - 2020 by the deal.II authors
 #
 # This file is part of the deal.II library.
 #
index ad8207b77e229672b89ddfaebb4a6e13fa4f3ee1..11d261706a25d54485feb6cdefc340789592e3d4 100755 (executable)
@@ -1,7 +1,7 @@
 #!/bin/sh
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2014 - 2018 by the deal.II authors
+## Copyright (C) 2014 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index f449c7607707d6db17ddae7d5527f2f945f723bf..a8ad86887db8b5b5404251382d4f1a117c8f1879 100755 (executable)
@@ -1,7 +1,7 @@
 #!/bin/sh
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2018 by the deal.II authors
+## Copyright (C) 2018 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index aa6a54201a796741a0ec2c40d8e6b37d80108b97..92387a54c5ddf027bf7cc8cf3e137c27501d2377 100755 (executable)
@@ -1,7 +1,7 @@
 #!/bin/bash
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2018 - 2019 by the deal.II authors
+## Copyright (C) 2018 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 9b9c6422678eb97783f0964ee9fc1638c976c0f4..f2f98c39f7ffc51c8f4d86d911c23b3be77bfc12 100644 (file)
@@ -1,7 +1,7 @@
 #!/bin/bash
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2018 - 2019 by the deal.II authors
+## Copyright (C) 2018 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 989d9b5ce4516adf7a2492206a0ebf015033e0d4..ac71db6ac5d5e2c8522bdef443f35ba147621d66 100755 (executable)
@@ -1,7 +1,7 @@
 #!/bin/bash
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2018 - 2019 by the deal.II authors
+## Copyright (C) 2018 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 808dc8cbca3d31f2c4b46d95598128d0d8e53938..a227d9203a8640c83314a9c61399d9ece6804dcc 100755 (executable)
@@ -1,7 +1,7 @@
 #!/bin/bash
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2015 - 2016 by the deal.II authors
+## Copyright (C) 2015 -  by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 8909e7a83db4e0e64208667f8e6a04debe7380dd..070c6f6f16917fa645ae197e8a0fd28a23cae0d3 100755 (executable)
@@ -2,7 +2,7 @@
 
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2016 - 2018 by the deal.II authors
+## Copyright (C) 2016 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 95a52eeb0ab14960bac7a01251000dce460cdac4..d54354f4ed0c6d31dc158b39c34f2396dfca3777 100644 (file)
@@ -4,7 +4,7 @@
   <head>
     <title>Build system internals</title>
     <link href="../screen.css" rel="StyleSheet">
-    <meta name="copyright" content="Copyright (C) 2013 - 2018 by the deal.II Authors">
+    <meta name="copyright" content="Copyright (C) 2013 - 2020 by the deal.II Authors">
     <meta name="keywords" content="deal.II">
   </head>
 
index 8b125ae8b556d49bdcbbf8d464e93b8736e8920f..1df58d12b83ac043b9f895e8ebc11a15e103dc18 100644 (file)
@@ -4,7 +4,7 @@
   <head>
     <title>Porting deal.II</title>
     <link href="../screen.css" rel="StyleSheet" media="screen">
-    <meta name="copyright" content="Copyright (C) 2000 - 2018 by the deal.II Authors">
+    <meta name="copyright" content="Copyright (C) 2000 - 2020 by the deal.II Authors">
     <meta name="keywords" content="deal.II porting">
   </head>
 
index bc6f6c2dd8b7cef0b130c299fb7639f13135bb1d..4e24b1634223bc48023893fe3b2dbe8ceafb23d3 100644 (file)
@@ -5,7 +5,7 @@
   <meta http-equiv="Content-type" content="text/html;charset=UTF-8">
   <title>The deal.II Testsuite</title>
   <link href="../screen.css" rel="StyleSheet">
-  <meta name="copyright" content="Copyright (C) 1998 - 2018 by the deal.II Authors">
+  <meta name="copyright" content="Copyright (C) 1998 - 2020 by the deal.II Authors">
   <meta name="keywords" content="deal dealii finite elements fem triangulation">
   <meta http-equiv="content-language" content="en">
 </head>
@@ -614,7 +614,7 @@ category/test.expect=run.output
 <pre>
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II Authors
+// Copyright (C) 2015 - 2020 by the deal.II Authors
 //
 // This file is part of the deal.II library.
 //
index 8a3bb35008d6bff6e2d958eb216b1fba354eb65f..ed628f8983ce35fccfdd2c15f781626d664febee 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 751851c733a26817935895232449e56ba71e2871..845e04546d816cdb6ed1328fb713baa67aa1a446 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2015 - 2018 by the deal.II Authors
+## Copyright (C) 2015 - 2020 by the deal.II Authors
 ##
 ## This file is part of the deal.II library.
 ##
index c69eb0e3025205fac6ff316985f113af295a6fe2..119c271d7e0955b2eca7d1adafc5d7852c5ba4df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6dd98edc455b8c90ce6fdb7fd63975dc8c62923..54720dfd619ca913d3590067bc016e4ad42fba3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2017 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f60776098627d507b6267641645349088fc3fef3..1c0338c68cf391436642c3009409ea06d838b1b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 56d278e0abc2575ceb3a7cb4df9e61a77d009ece..668bdce00eab38384d39464eba3203722276ac33 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75d54e107f98818c7b0ba554076515f3159e23f8..6a1ad3a54765d6ef9c9ae4e50a987ca08918d6ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f033d320d6d59ef05c3d76bb31d8c787a8e158ac..61281e4f89878651851c2e4cc9957f21368c1904 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0193468137dbbfd98e3793a9611bbed12ba036d..94c584b2890015556cfe59e16c9122e6996fc908 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 676f743d0fd54c6fb6afbc74cd6ee14da09b39c6..f5c3fd7ceebe23aeff74b47db0d46b23317863aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2017 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70dc7abd905f59bf75497b50f2e92326d88dd5c2..3587e7ce5333621c7127edf24e37be06ad42d1ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2016 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a5b4a15df0b63eb6e20f93716c46db6bf292cc6..b499ae118f6d9174dd788ce59b12bceeda008a4b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2014 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 223dfaf421dfd25805e4673565e0690e7e09ddbc..3836105542a9e8bc391414308602e6c32dcca61d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13ad568a1552bf20e947ad76a1bab2f5bf18391b..f3578cd524864004f397acf498b64e17dd24db2e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5eadb736ab96905c988fed4c036917c7e411fca4..7e321f375053a671c0f241c6e5f40bbfd2cab2d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fdaf57a7a2e6b34f9456609fdfdb5838340ae6f1..7a18861b87db935eefa71721c11c281cb8439659 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17d558afe035b4b7f2c41a5f8a57d96567850028..796fe6f163a604ba6672ebb905f24f9e02f268c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e93bc9932d54e3c5b9aa7f835bda2d8adfdfef46..4cbcf5e29e19356c8ef5c817dd55cc0d69b93222 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd2fd92c315ea119ed00bf5bf06aec1078059566..41ec4ac74ef83c5aa0668d66c9d9994bd24e6b75 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2017 by the deal.II authors
+// Copyright (C) 2013 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6d3c18de794fdf5ec202fdd3aef71a366bb0bac..0e09e31a0b4408fca06a1ac535514db416077aa5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07948f5ddfc33bb8d748f4378cd33a7b02db8800..f95a6076b5ae091aa1363b79fd83f0203658c09a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0f16357df34380e503f88655ef24943028ef0107..54663d6e0a625db4d7e8f998daf3af446fc6242a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cbc9fe88d6aac4b3a16e34696fa172919ed16fc2..62cfc506779e62dda14248ab64a31e3be3217d53 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c455f5df0499fbba80a1031a6e2c00bdb41856b9..8dc768a8689abecb462219a17aee83252ea7c443 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 76267beb09518ef2a94aee35b5c6d0eeab01d698..e560531cfa0eac67ef283d0f569fe7ccbd60c735 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 89edd1ece00c358934e667a50291f05d345c27d0..26b43df9b9cb2f13f4d7d33dc1a102714e2a67b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2014 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3bcad160e64433c99e5313257769100f3c2f6ca5..c718ff36d93a6cf3babf82aac77fa1b27dd505f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 843c57520a896f2fcb768eee47a81a3caf767a66..a1d28571d1f9164cf541b99b7ed1ea4164596eee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2014 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45326a4d688788100f34e1912a551b945416c851..3e5c68befc2b776e49e253e1cbe78ee8b0e5c8ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2014 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 61aa2d651fff3455c7d4b1c1f56e1ae6b26bb84b..daf508abbc25521274a9602cad9cbf3c51d6bbb8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2014 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c27c9f24cdec9c8516cad22fde29dfd60b747b8..d5f9e6552b6b3163618d73962cf4bb337ffe4f62 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2016 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64530058ba3db867b8c9e6480c79f2c328075285..5251d2e2fcfe18036ba636e91c9bf3a202a34cb6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2016 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5195da724a90e4d695b2f27bfa79d50196b9a376..906834f238e2ea9390cb8365eb7252c400d9b590 100755 (executable)
@@ -1,7 +1,7 @@
 #!/usr/bin/perl
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2007 - 2018 by the deal.II authors
+## Copyright (C) 2007 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 0089ba82b4f6742d978894e67e0103ad06e8823e..9f1e1d84deb70fca5bc24af9a1bb20f52e17e277 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2013 - 2019 by the deal.II authors
+## Copyright (C) 2013 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index f93288abc867729228d6b07d70ababa9a523cee1..ce7a3721c28edaa6181862a1cd7232c8d00c3c33 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2006 - 2019 by the deal.II authors
+## Copyright (C) 2006 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index d476b1be8ba32b88aeb4bfad2f268f4bc7990649..97573ad04da7d20dc6edbbd23363ae3f470f66fd 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2006 - 2015 by the deal.II authors
+## Copyright (C) 2006 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 105f027f5e31de4ffa5561ece4598a05e5c56ff2..8b96f00b7e144fd3521a6569ee1b612981e48173 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II Authors
+## Copyright (C) 2012 - 2020 by the deal.II Authors
 ##
 ## This file is part of the deal.II library.
 ##
index 951a5e360eff8132f89a66e780177c468a7f351b..52a222bbd56091029f220f9447cfe212b7fed32c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05817ef657b628192812227cd0d22eaf30e254d2..9da737de7a4471a023ef796613c360e9fd3fed27 100644 (file)
@@ -5,7 +5,7 @@
   <head>
     <title>The deal.II Readme on interfacing to OpenCASCADE</title>
     <link href="../screen.css" rel="StyleSheet">
-    <meta name="copyright" content="Copyright (C) 2010 - 2015 by the deal.II authors">
+    <meta name="copyright" content="Copyright (C) 2010 - 2020 by the deal.II authors">
     <meta name="keywords" content="deal.II">
   </head>
   <body>
index a27d6d29aa34bfb08e942c5f0a576db783c7634a..5437f20dae1c8463100c40b6a73e40d1e2eb6ee6 100644 (file)
@@ -4,7 +4,7 @@
   <head>
     <title>The deal.II Readme on interfacing to Trilinos</title>
     <link href="../screen.css" rel="StyleSheet">
-    <meta name="copyright" content="Copyright (C) 2008 - 2019 by the deal.II authors">
+    <meta name="copyright" content="Copyright (C) 2008 - 2020 by the deal.II authors">
     <meta name="keywords" content="deal.II">
   </head>
 
index ebe5315894a2d3ea791612359cc40332b9ae76b5..883654768f2b3469efd3395280f499cb7d921b44 100644 (file)
@@ -5,7 +5,7 @@
     <title>deal.II Documentation</title>
     <link href="screen.css" rel="StyleSheet">
     <link rel="SHORTCUT ICON" href="deal.ico">
-    <meta name="copyright" content="Copyright (C) 1998 - 2019 by the deal.II Authors">
+    <meta name="copyright" content="Copyright (C) 1998 - 2020 by the deal.II Authors">
     <meta name="keywords" content="deal dealii finite elements fem triangulation">
     <meta http-equiv="content-language" content="en">
 
index be72a8d5f56e0ae3424f650142ece5f2ebed7082..d13d9be77e6d42ff87c153048bbdbd4697a44609 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2016 by the deal.II Authors
+## Copyright (C) 2016 - 2020 by the deal.II Authors
 ##
 ## This file is part of the deal.II library.
 ##
index 4f93d593e2c543b1095db34057459d352d761880..db44b08335723b622f0aa311dfa2648dc3ea0d8f 100644 (file)
@@ -7,7 +7,7 @@
     <title>The deal.II Readme</title>
     <meta http-equiv="Content-Type" content="text/html;charset=utf-8" />
     <link href="screen.css" rel="StyleSheet" />
-    <meta name="copyright" content="Copyright (C) 1998 - 2019 by the deal.II Authors" />
+    <meta name="copyright" content="Copyright (C) 1998 - 2020 by the deal.II Authors" />
     <meta name="keywords" content="deal.II" />
 </head>
 
index 47d75ccb141a72ba050aeadd948feb9d3a0659a8..3e0e298a97b72bd2d59ac762a2308af51d2fe0e4 100644 (file)
@@ -5,7 +5,7 @@
     <title>deal.II CMake documentation</title>
     <link href="../screen.css" rel="StyleSheet">
     <meta name="author" content="the deal.II authors <authors @ dealii.org>">
-    <meta name="copyright" content="Copyright (C) 2012 - 2019 by the deal.II authors">
+    <meta name="copyright" content="Copyright (C) 2012 - 2020 by the deal.II authors">
     <meta name="keywords" content="deal.II">
   </head>
 
index 68ac7bb4f409707fcef7d06911ac678ade843090..a1305b1990640c2eeefc3e642bb18ded3eb709b1 100644 (file)
@@ -5,7 +5,7 @@
     <title>User CMake configuration - deal.II</title>
     <link href="../screen.css" rel="StyleSheet">
     <meta name="author" content="the deal.II authors <authors @ dealii.org>">
-    <meta name="copyright" content="Copyright (C) 2012 - 2019 by the deal.II authors">
+    <meta name="copyright" content="Copyright (C) 2012 - 2020 by the deal.II authors">
     <meta name="keywords" content="deal.II">
   </head>
 
index 302c6b057226f3db7c80714568e34e323788290c..29d89b15fc5c93f93f73b76925b604fa651641e4 100644 (file)
@@ -6,7 +6,7 @@
   <title>deal.II Doxygen documentation</title>
   <link href="../screen.css" rel="StyleSheet">
   <meta name="author" content="the deal.II authors">
-  <meta name="copyright" content="Copyright (C) 2012 - 2018 by the deal.II authors">
+  <meta name="copyright" content="Copyright (C) 2012 - 2019 by the deal.II authors">
   <meta name="keywords" content="deal dealii finite elements fem triangulation">
   <meta http-equiv="content-language" content="en">
 </head>
index 8549f137e76a6d34eb7c89d66690ca3b9f500a33..380569694903e6870a8da7aa10944895448090ae 100644 (file)
@@ -5,7 +5,7 @@
   <meta http-equiv="Content-type" content="text/html;charset=UTF-8">
   <title>The deal.II Testsuite</title>
   <link href="../screen.css" rel="StyleSheet">
-  <meta name="copyright" content="Copyright (C) 1998 - 2018 by the deal.II Authors">
+  <meta name="copyright" content="Copyright (C) 1998 - 2020 by the deal.II Authors">
   <meta name="keywords" content="deal dealii finite elements fem triangulation">
   <meta http-equiv="content-language" content="en">
 </head>
index f5db9c5c7aa82a0c0c18a2cab8f8a1110a46c028..f7e2854207ccbf13d5bcbd7cc37cfa7458bf9207 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index c68e70d7f4fff73a29a06b3b05d5db3cf2334560..67b4b1cb29ec1c5e63319a4c94e11db811f7b19f 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2001 - 2018 by the deal.II authors
+ * Copyright (C) 2001 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 5f848fc1aec0589121fe6178c81c3289e861cbc7..309e2336184daac8a502202847a4a9d9e1cc08cc 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2001 - 2018 by the deal.II authors
+ * Copyright (C) 2001 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index f77d524135d4ab120d7e5a3ac17df20ab4fb34d5..d3789e677df2fd29718e972aef212206396b2f57 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2018 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index c5081bee3a28f28b9c5b74145743ea48f1b01485..fc6c72445ef8505f275feafa1e029d5e3ca7eb55 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2018 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index d77583bc2de72907f3a031479e2b15c4aec64ba2..702892c62b83c0032dc1749533fa9683e9f2f4f8 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2001 - 2019 by the deal.II authors
+ * Copyright (C) 2001 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index e6274798927d88a307be91f6474c4d7f76817790..3332f75102f0046ca4641880ffd3648ba6b1cda5 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2002 - 2019 by the deal.II authors
+ * Copyright (C) 2002 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index cbc9197de5c46ba0c35d2167632e5e84001d6492..7f95648f1fbba4c1b2ceb0fe76dfd0e20c6a893a 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2012 - 2019 by the deal.II authors
+ * Copyright (C) 2012 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index e01f42dd3df904fb6baf39de5dd3028a770a3322..291a964cc750557da054ec728b50f9bcf96eb5da 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2003 - 2018 by the deal.II authors
+ * Copyright (C) 2003 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 947c6cfb74b0ce7d67de759640a5a1d6489bdbd7..583524fab314b2414260a4c92cf7e8ea2a1ce29c 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2003 - 2019 by the deal.II authors
+ * Copyright (C) 2003 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index fa9c3e28aff998c1d3ad4320a388824514549173..21909d6d505e2f179d503613b34608f86187d9a2 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2000 - 2019 by the deal.II authors
+ * Copyright (C) 2000 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 429e87868af40b5140fda7ca0e6590826dc5614e..9e888adcbfc9bb628851105813c6d956731db43e 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 1999 - 2019 by the deal.II authors
+ * Copyright (C) 1999 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 991909cbe0ce906ec685c0bedd8b4be4a5f658eb..d3ae850cbeba7f8d9f3ca72340cd1aaebab88205 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2005 - 2019 by the deal.II authors
+ * Copyright (C) 2005 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 0496308840dfa96aa51dd725931bd6668b834527..1f4b131b474dcf74d17514752ef0e647ea8dce31 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2006 - 2019 by the deal.II authors
+ * Copyright (C) 2006 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 8acedcae3df391228cb7b0439e4a14f51be98e60..9febac04c583c5028f19eb94d468373473e6c5f2 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2019 by the deal.II authors
+ * Copyright (C) 2008 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index d0ef39b30a28c8c0a69b584af6535860c6b0f4e0..5b44c4f2217f9425a17174e567ed5222946b6f30 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2006 - 2019 by the deal.II authors
+ * Copyright (C) 2006 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index dc6dda347be5b3f070af7b21161e6219851b115e..058c49037a95cb5f7839bffe46a935506d75b07b 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2006 - 2019 by the deal.II authors
+ * Copyright (C) 2006 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 3e1e37f257e7f0e32ddf911ecd16dba0179a95b1..09beecdb4f2c6ca764e930b7a4279507268dd122 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2006 - 2019 by the deal.II authors
+ * Copyright (C) 2006 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 02479f90ac883f98e3ccce920e3652897507ec5f..fc07cec0dea9becd0c9090b55d649d269221e513 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2013 - 2019 by the deal.II authors
+ * Copyright (C) 2013 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index c5b4eec35fd9e94ad6f00d62d46f2e56e169494e..54fbca5271969e9621c9e8642da347406b22b924 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2006 - 2018 by the deal.II authors
+ * Copyright (C) 2006 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index f930c5f8145a666ff7f34f9f4129a1edded71e21..e06dc8820691469c127821a7e2e98ffe9b4ace03 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2019 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 0b196c4306d4b626dea87e243422e660f0d0fd4c..c76c718a094d2ac66d4d6a2dd12a511719f44f9b 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2007 - 2019 by the deal.II authors
+ * Copyright (C) 2007 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index e8fd779d8ef0ef6fab4c392cf1649da8c99894aa..32972d4504e0ef5c393f13051b583b8642e4c37b 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 1999 - 2019 by the deal.II authors
+ * Copyright (C) 1999 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index a25766ff87cafebabd4732f15bfb70257968f7a5..e24b8ebfc0386d22702a0de550f8a478801032fd 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2007 - 2019 by the deal.II authors
+ * Copyright (C) 2007 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 03226e91de3f673df2f5698d7c24ab09648e2c4b..a0ad4a678424b0a0acd6f67e9d95828266e2ef16 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2007 - 2019 by the deal.II authors
+ * Copyright (C) 2007 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 19a1be8b212c4d172a72c4b2d536f83995958c70..d983a56f8126f523c339d3de402d5edbbf856cb2 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2019 by the deal.II authors
+ * Copyright (C) 2008 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b0539f415172e86a7abb3d60b6d13f6cbf056ce2..ba56ae6a97495b8ba1ff7c5d216e14f46cfdd2ff 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2007 - 2019 by the deal.II authors
+ * Copyright (C) 2007 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index cd77ce935f162af03db7c3e9106bdb98b7e1cc8e..0ce41220c03094261ffead39210f615a5c9d5eca 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2019 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index bfda44b687eccf4a292e63d45500ce23b20165d0..b48218bc5c93003f94aeb7b358031c348a347b47 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2018 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 559ef80ad4bec965dd0c5f8aba185c752d262fc6..e7ecb56badd77db992494f796ff8bfaf9e0c1260 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2019 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index c9de79bc91d4b7ff0ac6aafd831caf0637c2a916..84c2b21c213dc7db279c0dd5cf47ebdc1ca16e2d 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2010 - 2019 by the deal.II authors
+ * Copyright (C) 2010 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index f508df316b054103a03fcafd1485fa2745db4289..e60fa633e23d14275bf76c594b0aaa511831989f 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2010 - 2018 by the deal.II authors
+ * Copyright (C) 2010 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b34c5c2dfaa6f61141e5e3ff2bb9bac4301761c8..3fe7b9c6bd9f50fde4fb0637711af32fa1cfe8f1 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 1999 - 2019 by the deal.II authors
+ * Copyright (C) 1999 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index f9a5f897781728950ec3dc5d37e430d9a59f616d..4e2d4811599d28f92deb0f70ff9011249680d5f0 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2019 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 1963fc1ed24f0ad72397d1fecdc5ea7f1ec68511..87ecfe7284687d921ffd413e5531291b4a68bb74 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2012 - 2019 by the deal.II authors
+ * Copyright (C) 2012 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 88ad89c8dbdd70f3f923e47d1fb36158568058ee..ea33694210f4ea78e726c873d2d31ffb0a02be93 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2010 - 2019 by the deal.II authors
+ * Copyright (C) 2010 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index dfb11ed1bbb3a5a282382451df522c4a14aabdfb..d97f7d3994b07a4c583175960831d39e7c0c4869 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2018 by the deal.II authors
+ * Copyright (C) 2008 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b370c2f780e70306e1b9b22b027fc6d1cf25f54e..46bef2efda93acb5f3572dffc14cd32c93a81722 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2011 - 2019 by the deal.II authors
+ * Copyright (C) 2011 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 7bf7c8ff0838ba251c2fa5471a4383cf7b0f500f..cfabc753cce2311dff1e30eb424add4072f5eec7 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2019 by the deal.II authors
+ * Copyright (C) 2019 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b511fef931d019133cb293a9b17c84d69e978e47..f228ecd7896b59d890a9e875ef336b7e082889af 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2011 - 2019 by the deal.II authors
+ * Copyright (C) 2011 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 49b2879b659ad927d4e88f202a087c45d840be99..dbd7d9dac51d981ec794fec0bfc5384673576112 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2013 - 2019 by the deal.II authors
+ * Copyright (C) 2013 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index cac2c2d6ead7bb9359a6c4a65d17787aba78a7b2..78c7ebd1887e26fe6da9351e5fa7613664479570 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 1999 - 2019 by the deal.II authors
+ * Copyright (C) 1999 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 2a0f20362efc8bf97bf383f10cef83b786748bb0..815094f8b3d95b2d10c895467111f0d9a31aec2f 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2003 - 2018 by the deal.II authors
+ * Copyright (C) 2003 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 084e5763287dd40b2d651cd8fdba6cb55e7543bf..b44a8b022cd41ac0639faa2edebac0ad32f35687 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2013 - 2019 by the deal.II authors
+ * Copyright (C) 2013 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b29d884970e4d75954c3a835f165c8d1c7b6df38..2e6928bd83a446b43a955273620aed37f144a8a6 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2014 - 2019 by the deal.II authors
+ * Copyright (C) 2014 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index e21210a6c1067d5bb0ee0ff06614fb1ee554fd07..69b8179ff8ee1249f3e1b2ba93fadcd76b95ed06 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2019 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index ebc29436fa7e8a89d07d4501839514db000be6b2..24027299dd12111be664313f3a8850a63c49f8df 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2016 - 2019 by the deal.II authors
+ * Copyright (C) 2016 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b3e1d4518245f30d720ee3e78f1a005584f9ec0d..3a5f57b71dc225642f56443b3498dfbfe920a2df 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2016 - 2019 by the deal.II authors
+ * Copyright (C) 2016 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index a9ba43c83724fd45df32aaac13442538a7223101..10d265726dfc1e94b11e87d6cdfad34880e4d9aa 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2019 by the deal.II authors
+ * Copyright (C) 2008 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index c4d55d1dab40d52664e634c690c9619333fcaf8a..569b9e9464eba79cd3b4ae7cbeb5c2331df8ce8a 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 692a92bf017614d546a2d161e32b40b3a1ea28ea..2a14b4b0b7153a603cb5206322b015d674ae4452 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 8e1f3d8096f0d63b7c35c48ae18fdab742fe8dea..508c9f7c271d3894f229dad1b2fce283ad631a33 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2000 - 2019 by the deal.II authors
+ * Copyright (C) 2000 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 5bde5821763ff48d89a8d4883bc08b88b7e289ab..acabe8459191ec790f9945f7405a6359a3780b41 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index eaf59d541f074711f3c19ecbbef5c15863697c14..459512886f49c8f00852351d1567f4f0be72919a 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 64c202321509c935d3d454f4d008cf0b9cb58fdb..0840067677a2a29b944824097999f14670f1c7b3 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 7d13f0efddb785b3e31e4f191bf656bab6558bf0..67250df424de62017aa41b74021284f226c46701 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 6e70e4140f5020a362154ab03cf2544a62c53cfb..f32918497890c57fd5af5c70ca8aee861c04928f 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2019 by the deal.II authors
+ * Copyright (C) 2019 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index c413a50eae70dac755d9a72933e25deea1a09bec..b48bdb9081441699e3b58f3fc02284b191824270 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2000 - 2019 by the deal.II authors
+ * Copyright (C) 2000 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 6551a774bb297fbd971e873525cbf51df3db19ad..48bb0406f9260c8ab1ce976bcd2871e1507c5a34 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2000 - 2019 by the deal.II authors
+ * Copyright (C) 2000 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 4858b995cc721c0cf8fcc1661b13503c13f130e0..86daab2d0da45cc4e9b526006733c9b57d9884de 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2000 - 2018 by the deal.II authors
+ * Copyright (C) 2000 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 95a8748fc239b706e220d56341463719fe93297a..890e0e89d2d443b4f0f50299ba855f6fa714a102 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07e4ef5c82b6cc49953ddf708abbbd98c5219513..06a7488d5bbb5df88d4f3d123fe3a81a8fc47283 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 925563e1031daca2e1ffd742003a388c0db28fa5..ac99aa7dcd1fac8b72eaeb497d51dd536de584c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ba8f4514622466835975a0157ec0fb4cdbd9e6d..2976c47f6b987f7d69897744a1046769e354385c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 835b709924b84e11862ede1f29507d1a1c1c86d1..8bd0aaeeaec46d143e61bb312e62bbe1e2c5fd12 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e38a881a5dd2da9c796bb1c89749ced7275e41f0..9b56654bc8fd99f1cccc93ef2485cf30b294803b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8e041a35d0b39d739fdae8331e2e04d6ff53342..08d271b6fd09fa6727680ec4a8491c10286a4c80 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 027b300aec7e38e0df10d7c8c969c60f2ef96b97..d02fd71e2b9f59b525be62c3f674f3161ced10eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9ef7ba1a294bace9492b433c2001781aa5448ac..f71ecdeb0515044551dcde9745c573d38d96c9ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d3002411a017eae5cd15fcefb0f3c5ffcc6871c..f837743889cb39a59b6a80c2ffb7604486fe33d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f29b3ea2c1c6e28d780a80097d16d7527e58159..64336a4228524792297e0857b98764ce5773cab0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1089e04c5756853898093f11752863f54e79a045..3eddfacaa227d28e21b37a1ab4b422e35ee3e30f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40ff606237708e859e4314873db3462f249708f6..237c46aaa692c99d84780bf4b9531f7ca83e1627 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2019 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f58db4a988b8ca807751346e4f3565861adba99..7a72f75c4995a2e85201e5fdf054f25f8e8694d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1426b2caf3c66a806843c1b83e4a1190896bc830..4f246a3c1ad549845ead0d483dd298e8e9a2fb68 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b16d95a4943eff0732d0b221ca432083d12d5b1e..dbba0d12a5d18839fffbe1902263f6d833523672 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 56cd3469b295085ec7071b2b4a253df2f887cc14..8ac10ae560c6441f273a6dc89e362d16efd1924b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1dc24a9cfeba8fdc3db50e6462a12aef31fab5b0..942c6655781026b7b62b3ca2a637840fe88bfbb1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d68b06226a7dbdfca16f3133f99c61d1c23e0113..c4a64a595f95ee732629354baa31d131ac8ad144 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad4960efd45b20499bdb63dedf8bda74ae275749..cfc50cfbb5069739ec65dbdda4c04c754eea7316 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d91213ed7af400e8881d2d36deec9312c6101aab..60772c85af87ca1b7fc0ab09df98235eed971392 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 442f25d94cbebcdcf5fa193d4f8d63a8f9cf04da..265cd2cb76b509e77896cd82121184418172de43 100644 (file)
@@ -1,7 +1,7 @@
 
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2019 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64526f52c0a45af1d930634eee2633f8a5b60e13..781eefaea69cca1a8b2742c005cf607efc1f14f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfb8a6e43f25d72c592c4e6e087d986761a16844..7003921a70bcc107981bbdd0e639967d52b19dd0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4af23963fd3effd3adf2efb9c22e770bf81326e..d088b4f3bce0345d5ef8ca252102758e89ece22c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2019 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9b0cf03d82179cbced03cd22070ac7f142f594b..5ca01a853bc552d60dc816c8fbc687edcc9bdb30 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 491c465303952f4f62b703f2e8ef7482f26cd913..d15ed1a9865751d9d0f5a2a18b9ac1bbdc1a1f22 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9042ac105e8c63b3c194bb207a77aeb9eb2c13f5..4a8e67a82f610511154cb20e838fc50745e83338 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a6ef15bc7b391877063196dfe9b3128439766ff..c910309cacf1bd0732389876c062f8e87b739dab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 58dd3a488142cdefafb043ddfc72e19200233e51..bbb9d54f46551ab556d2d12aca353f3d86043ce4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a71ab36f4932583dd164c323182aa4bb2c0e2ca6..e429a076b4ad1ab549a116b9bf184089e6d784f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 326dd749298662fd1b29080d160e6b56acfda861..33afc8c1a1581177fd4ee56c8f0c8d1c30138335 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 757817f1bc555adb14af63bf78d80cb14196a44a..6da99a594321dc28b8ec1f9ce450e33045d1f4c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3cc35e1d397920f486d313a4f140c400579c27dc..a8323a0131d3c60ae95a0c37409cd0decf4827e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3846c95737ee0352c93058ecd82f5cb5e1f97d80..a644b4fe2e1352f0eb00bd688e58ca28a6361eb5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0db8c9e754db770a2e7aa0ccdcb83e32f70471d..a922b91479d7865d39b1423028c6e15da5f1e320 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2019 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2c542c0608180a96c12ab3ff9fac2236e6061a2..a66badaa86a343403a88ba45ee577c71c1fe703c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee6ee8fc6909bc8149937f30b90d0c2b3a915206..0838d685d58755d7788641793c48a83fc566d53d 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2017 - 2018 by the deal.II authors
+//    Copyright (C) 2017 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index e5617f44b96a8d57ea33f23fe9d58eb42010dbb1..206401efabb371b6cba607d13fbc10ac636442b1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e09c401024ce4fa8e2600745ba4a23115f0491c..288b9b2f89a1f6e27d7ac7a305d4ed5d25c4898d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c21508a3953a251cc9af4a7b8b42f7e23585880e..3fa1393b8f94832b713c09e311281895310bb699 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c02dd94e8b03895fc4cc83432028e1fd48e87df..6072dd3021f7688b5f552629b070b5182e816527 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a041b37322771f14b6169ca29034fa6661c137c..68e26211597d2a3cbd883aacf3ec5bf0d8708990 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96f5f20d76dc4e058985b6685617247e6797d0c3..e37d5bb8fa4845f70c0c89b441d481f1bc788793 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04199d064df3be587809783f9d2bafd0d1236c46..97b4bb23e51e9cbd56de466828d003b672cb3888 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bff0d248a936e0c4902aa6be05d8d1cc3ec3ebdd..e9db49040fed634895a1264ccc3c7c12f025a0d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed1a0a5cfd09d95818f1cc742a8d30cc24302762..befa63fb8a62280b5d60529b6fdf8bce833c26ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5c6dc6668224649934003516928942c254bd8d7..39a97f734a82389c048afdcf9a56774071e5cd67 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b9c0b6a06cdf2c37962210ab942a6bc6d5bff0e..4d9ef1b3bdea3d4959bb162810d31f54cb03d700 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e4cd085a79764f25327f468257fdacb1e529782..04f2297e6bf894a5c907a30feffc344a3816e016 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68daeb5c8a8b3105ed2523fa8ea37732b1ba0cbf..86cf12d6de4f7ff67a5460ad82f8644221cc1c89 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 73f38ae1a73e7fdfb5ac6a49db64c4784289e6e5..b59a2bc121490be5b449f037436513e49dbc588b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a20fd6fe564829a526e541f3fb94afa2fcec7ccb..732f355f5a5efa5174e8f3425b886e0f2873f142 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d1ed0fa8542db2e4f9c9d48589070153dce42cbe..415462e433262299305516a03218eb7c6867c176 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c040928c57bad8bb273f4cbf1214a818a4169218..b582006d56d6d1b45f9af023dad6f53a4fa28a4f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b56598ba130c9783f841d4fcb2623158f0fa908..0a75fec8107ca208555bc799731fcf4577fa90a1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6bc0b543298962cd65b575e3082dc13eb73c50d..66969921a3828b7b403714dff97f7ab16f47a092 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 83e5dacfc86fd7360f7cb23af337f99a2dfaed2d..79475f8bf1eafc90357d870f8e233351eeb8c8ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 679b1bba537229b7632b6f49f8909b367c2d8ad9..ca3358bbc958ca01777c8723f12b797f51531e5a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b25feb86f1b99cd41f18066474e7a1852e5b94b1..75e3f04c69c80dfb79599f655c84cbc9cf4f87a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7679316c3671fb6d06ee2dfd5ce38762b4a77dc1..a99517ce109a5b52532b8b911b8386b61465406f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 08e0f41bf66e00538f4e421a241aa8f4a9b2bc28..1e1dd9bb0163983aa5d01cd654e132ce308a2e71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b192a885cbc3ec80814c00db17cb145038baa45..e74a95768088865fb0f4880a9975681a9bca2013 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 27bd504ed62e12f670c3d936bba1fc9eab9e86a9..d90d722b6f724bee08523f7cbd6452b6ee57fa32 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f30bd7441ce8506335a89c48cf934af08743ae7..b71425ec1c0613f96686c601240ddae3279842f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8788b60bad152bcefeb26306e8c79e802c40ec3a..164d3740b39ddf5a0e409be7c53f0a59ff493e3e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32a65c48c88b80e8962aa0cfef2e35f5cc19c0a6..830e33195204dc0b6749487512ede3ed007d1dd2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70df66dffc63d6384aa310764f82401bf91c4404..2a2b02dca95573528c7aebafbe36752507230e24 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2019 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ba898805301bb43f024c7fa55909160bd20b6af..de951a328df5ef12b2d70b57364f912d59bfe7ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71e6e3ef3b6a0ae435f4239af98ef1bdb36ffd50..3c9cd89677bf815fa4fc248173b9cc1ac4359f9d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5180ec1ba0a79f1629031d54b12272a2bee9f76..b80d5b71fe027044ff41141a9e0977c92d98f1ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f2a9a3f16b522ffb56743a7fea3d9ccd583e9a1..60209530b88293ac955d48dc27be4cb1d60e6ef2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a82c4027ede34e397c7c654cbaafd21a96ed7188..101a702587b26670d3859bc14ec824a480bae943 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ee8c802f2aab0c39b42854e34d090d01805edaa..c9228265ddf63c5b3fccb1eaf2af24a083ca44aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6bec0062d24d04d293e7d7cbfbe3298a6597aaf..33b8e893a49e4f76c0f5dc99701549a366205391 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1bfcaaf4d4f8f6b4d8e2982f3e70199fbf510335..48b368626e217e983ebbae3fe95b761ae0f416a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc069adef485ef06b79113bc1357ad34c38d00dc..d2c31c3370abfcab8233d6ec3e9be8f5c7563aef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b693fabc1f71eb01fd99696b80741f9c6d90069..05f61f2e7d7a21d0ddbfbc60649c6f4839008b6f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 817fe0520eadce1bbab12ea97359ea39afeb6aa3..d2e94367c3016c173b10bd773efdd120e47f8590 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71983e68d334fe1abfe1b11ffe07894b26079ad0..563ab6154d0d1f537c6e9e76e249e2b8ced567cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8fe4585b28e50ff16659b53bfdb0b69f375da54..0873c3f95a03664a731b908059e60e2fb018478b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 586d09194bfc61a01ab35027b857ba21b41b9be9..e28cbf098abce4514e46ac62c9baf8bcad6943cf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e3828267ea6036b1830e6e15ced054a40c7862fc..9f0dd01986daa47cdcf62ada41a35c5b06e7aa33 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60908f97c6cc03918f44c1badeea3a4d6271c238..e9541a50b5e8a5e1c43e2061d632ffddebd0d3aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b9dc0b34c5e903856bbe5e983fbc8ae048a2b26..a4293af3db121cb72d0bd541188a592e1ed76055 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0f705c684430e42a16f76325ebeffb5060b3f65e..e6cd2a5d24388b20b8a67c5babc4423b257a199e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98bd062da3b5055c1fae1e93e346a16e6bb9f316..4549e494c9cbacff61a44d378c8d40082d94a7d2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ac2fc980e31f852327db1f127910ef3320dbf56..cb1803c5b93a44a93f606f93031e32b293d41d89 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f60bb62c1e783e0fe3c110e328e813212559c4d2..6a1ad0f3a1e3d207d90e86f723af333689e4e944 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc4733ca68333ad0119dcc5b55b16e8fbc73b351..c84f3bb2d12158de52db33b01fd79cf448f320a1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9681a3fe9877e70f3e146adf24fdb5e91bfc863b..03f877bf745e1e1f8648c35173b240e1ee629ef0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019-2020 by the deal.II authors
+// Copyright (C) 2019 - 2020-2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a1405c2d2c195a2a2ec4f00cc636a4997fbe6106..aa404813c28f6515043a7f2dd15a80539403d6b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05e25e2234880ea46f24a9e7433cd3d5ef0de903..8c60012c1bf1db3db059bef6e6904c13096d256b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50dd53b954e124e388226b911cb6152e092ca498..4113bbec71ef8e80d3c48eeb19d795868260fcf3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c1d8ee36b9ee970fb0fefd369426d72bbdf04ee..9d062809faac937ab11bfae6313a39cc04584ad7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22fcd228652d05764dec21b6a17064a6b521aa97..eda3bb97aac1b2c979b4e2fc1af9c4e32602ba88 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77a763ba8b0e1dabed824ef7bb5ef2b635130c89..0d48339d3ad021a187576de5f14c7131a3c13348 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4604e548a93f84945916f8cbb3ac32ee18a549e..45a282a533447a13c6aa924cfd0aad5a14b969ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb133907d1e90490e59f5a68008895362c9a1279..03b7abf677cf2c2d641fcca382fc46ccc0c5b829 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87c93a85408cea1a03ae7ac5635027fbdd44d1da..219db47eab74468db743e2db9ba36902bb956c70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a31a9991d38e5d1e40a906cb4beff8b20d6473e4..c253c2d173d2259ab373592a8cb90fd0d544b5a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec641657a5806c72f3bc2643b561000503ef865c..b20d049c9e44e2c1c56f87875216e3c1039ee89f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee748a044c73d06a385a40f5dcb9cb9cde58eeda..af5eb4ce71c0e9e40f750aa948db237d6ddc68cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa6a638975157727950b1fa0079a742c6bd38566..a962425706da43cba183c489ba117b2b37d83440 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c6616705014865d5af78c8735523b3b6c2c86ef..6e45adaa50bfa1ff2118a50f9890e835149bb059 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0bfb069ff86045419ca49eb56934ff8feb0bfae6..83fa34295eb260278a1f1ff88e760c66092e3033 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1cbb695f1f04ede034ea1a11cbcc4806595313b7..4c5858c19d4ca479596397d2959d8dbb37a8f98f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 56e8b792f0a3be0e2527f032193771963589cfa0..d970baa15700249b570a6187d9a25a9aa942bebd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2a56d252c14981e7bd502c9df6da78e9fc32792..6539d06799e7b9c546a8a55b8bc3bc52f954c069 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2019 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9765cdb87438a811762dd74f12fa704b83a8391..9330ab12774c1c769bc868558be25c008d824815 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2019 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74bf5adde2238f7a9db4c49b0ec8648f2f85eeaa..cae990e209bbf0fbda20b4006c78e91aeae0d8bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d26f0a9a3ef115980ed58d7c1e600b64aa84163..49904f021c783a7de2063a705ffb2414709303d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ccec16b47f903a144e42a7967cbd0efe32e5bc91..62fe89f643fe8a04b5f040e70f0ae5930f0ee1fc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 428b10c5723c39381e57f702b418bb64c43478ca..973cc8723078d9e40b1450cb4fc8cd5b083e4934 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3706780e96da8f1b67b1c426c598ed5f603ed927..dce721214189c6a64e155491bfe4b4e100317735 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57a4007dd2274517fd66fe123ceebcc19922b42d..6ddfcadc9e61e33c96ec07eeb0de744fd29962ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 26705d2c3c4691303f0b548c2d063a9d1374b7da..26e3e42a5b482e9e53a3b88cf1c42942cd79520a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 748f42fa86aebf471c728126db0a93e732a190ec..ef1a80ae183362f3b581728d6df04906893006fb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7c905964ebbc85e087c2a8825940370b905e153e..e13b965ab6abf0711b24047ddbbca0a49411089a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3e2593feeffce002e34d4d5a40cdb237a3f81b5..edc58923d83be91988c3d816e31c668a79a4449e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93a279e0b3338842f7ae5fd4d7f162140d9bd170..4d513846c61e71637d1cc3c167ed58c904f3a12d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6861fed40f7e0121d17e3f70ef6bb30159c27bca..8d922a49b95d1b04371110534e8a4116b49795d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7dee6de08d0a2d840db7a4c451bd085dd6870b84..e4db0c7f82013b5c15ec0d01ebd1ae20b12879ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77efe6a4a57b4aa4bbfaf7e39889992941535aae..762022db2240764ce62af5e0835de6b243d274e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3cea1551b1012d5ea6757b5182893f4cc838bdba..77f62a1e2133b9734f66d113d47a127feb49c208 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ccfbb9ce49ed92af24067711c4cb0c86e9869ae..68f8b6dc2a02bd827d1718689a3ea7f2a0f4dd6d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 294bc6e80dfe9ab52da501f64b9bc679a97c8765..48f2dc887b5762a88a138b8f84f8f53ffc7a3f5b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5828c6e970e45678621d047486510d1c95384dd9..5b14ff1bc3d5d7621df8220b21972a98be89c44e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 250e98bb5959ae6a73fbd38d3a76467c2fd89d5d..23dfdc77907976b2577828f69d50339fc4d12cb0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec55acc86039e9513d12f15a6344e546bc0edef5..595611b7c0ec6018babbc3b971fcf69eec6ac24a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0cacf22380086f067421e9cf3dd9d6f105f1240..11da8c6807bf14657a6226357623cf95346f9da0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8e273eb759beb60d4a313c5fb20985ff63ba40b5..c2f7ed87b85bb9ef39be17dfdba46786bbd931de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c07f1b2b7180e6e130cb33926f8a225f2bf7d11b..471bdfcd2a455d3a9405c05caf8a0c0878fe87e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1872d6f2ae2ab5588bd7d936b58b201f010c9a7b..060f15571720912c1b91527ebbb32f1dff61c37c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b631e1bd60148287eb99e60986c8fd231f766431..8eefec7ae619d26180011a79f9b0f166d7a14590 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6dd4b01297caac8ce747069fe2b371ce3dd86bd..f7bd10082389e59e13fe1b73f61b9f189f1d67a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b4f5cdc9833b2b0ee6fad7dc98ba1b934db6b2d..b108dd5e4e42a6190be3d4c8a0ca6d5517684e03 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d81b12fb5e75758d2ab821ba48de513b9c53c62f..dcc57c08aa36cb1c9ad637adae858b21817278e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ae8ba2c9c70170bc18f30b7b0febc03c08c76f8..cb2ac3b01723cbd03a9103be445cea098aeaad42 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f0d58cf95ef2ab98159a4aa408832af203f0426..199018e19151c023d3ee5e71886e31d259d09e5d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70d5e39c0e4595830fa73b235ba72bf23bbc5d3c..1fb50913fc8eef08f19ba9c1f7ad2f8ac3488eae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0db436c8141b093afce0aaa29f4150d4e0382646..f17d0508f9e1a2cdcbd709fdf30cf16dd90ab4ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e66dfdb137b4ec21d35c1ea3cc70894997c6f19f..a04569040904c833f89775de0b89e34d6a1f007a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9119f0cd4485c74161397af28a55088bc45a519..a8c4a5bef848a0159d64ec840873e845a8aacffe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4eaaa422a9cb56c60851886a28f72187d10b831f..314dd168afc49f20e11e4fdb59fb3e8b01e7e0ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 239d52ec50af0afa5da990d9f2388a50db6f41aa..4b911d84a4a21f67421256b625d2261dce9a47ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f628f0b92035670d6dc3202a0da71adbe0b39098..8930462d912e5bae849b2035875797ed11d6ac15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba376ac26ee6d937268ab5cb7443f1471a1a7f64..eab1e6386baff475715fc3d8fe04e899f1b7c95d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 661cc7c69eb0907404cebaee09cc8d1bdb02cc8d..982e97b01eee83f8b3d3c89bc8fe720d25e3b24f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2019 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 396c3ff0d38916422f721e88fd421ced6105c6b0..0684b4403395d7161abbd9c71b3174b75fc8d6dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84e2f356340aaee5aa7b6191cede748aab1907a7..c14680b022a0519fccff844a058c051370056e58 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fac80cfa303fbd53fb598f9ce7986ed82cb01a44..ac8ec5fa2329b71850fc9517806f8e95aa85856d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af09fb1c5095ef141d23a87c654b640e2eb7db3f..8b2dfadf2bc25f086aee33f6d2d463f7b695e4bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cad6b603ac42e25faeb7f48a2bb7fb7e3072ebf4..b3935cd15abf6f60dc7f0a203ae999f890c25b79 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e29da536c1e9234f18f7a226088b24555496d81..20e21373219178730567155fbc92f25f29bf6c17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 041e420f7b4eff7c036c72ec54a7dda713ea66cb..e8c9143fe70e7b0abd260924f2d29ddf1cbf1393 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7447a2cad447990984619cc728febf4b5b5cdce..5443e85b7b152e39bc11a2b361419507995d2bf1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6e56432cf38e1936023e842383d32a9feb54687..21cc8e5707aea2a3825418c4ad20ae3bcc27b255 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd51bbdf7531999bcb6f190055a004dd9fbd7690..db99e0544be698108d38540a3fffef5381c026b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0832b3ca312946e87f3b37774b48d5205fdefb2..ce7b25a5f0c70f02a4eebfd4898d646413b67385 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0a10f137551433e77703994f788e51db1e83c99..c40705d99552cb3359d2486af86c0e46e8696130 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88737bd62a173f03796e2fc393764f4d65f6a660..71fb1bb4ede437d3510325bfd3829e898bb4279c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91f96cceca14e6f1b858a682b82f1f002128ac30..692242254cecabe9c10321bbf4d5aec6bf64185d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70c513ad366ead39f8f3f8678abde15b9a9d5f41..92d157253263f82f57bb1d6d1ee0cf1ddb6119b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40976bebf04c2199d90f6a47a64a609ae41ff00f..07a999e04b83472dc94c807f44d4320ba68db40a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 123db9be92cafddb17e05060280898c06e4a5250..704ecff65d8b4fcd229f5d5539fdf70468ae53e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d19940867f334b89bf51921bfe98c197832db7b3..a93ed5b371e2b758e5c189e4a7b4ebde9d947c7b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf650638773c01079b4537041f0b37f8072271fc..a377e0fbedc93f7b9483de3594a20661d796a8d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3dd07decd6a66e4fd26a64843528ff63193e49d..e14321188489b427571e39ec3919853f8786f9d5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6a5a2d1cfa866b4a071a14c84a1ea661eae427c..1764bffd5dc60027940ef5e4e8b3beb77df72ddd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6a2a189c0e29d5a7ea8366c44e30e28a913ce45..6aa1fbaa904d29a6cb38d4ef0d588f486ecd76ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a391abda8344df96da98146f5a6d9e510f20249..c9997891a0564c34c76c5fa14a9a8c4c8ead13be 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dbfdc705d3686320b9a7c19fe9004303df0c4c28..9f9887829686a99d55edae8ab5f01763f663ed84 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9db3b36e2e84dbf3d973d7475a2eca8b39407295..2d7b1fbd90dd6a86f71edca23c02fac71ed1032a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbceac2086eb90c862bebe7dba0238f33509a595..0fa7789fe9cc46bbe8f63dfc28e2bfb4f1c30724 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ca5af6977e0f4938ccdbdfa9095ed3901ae3e1e..46dc028c7937db13ea1408e455de1a613cbdf020 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b14df9eb669684023d11de49d9d75e15fb212db..397dd08de97a08f913f8423fb5333e366122ae6d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8da555b658e0ba6a8b5023e91bc6c148bb0cf9bc..5fe2ce6d627285fbcddaef146d0b944c1b8abb1b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa251ecdf913678c21eb8ed21a641542c1291bef..b9b4fa97f99bd60cc76904a19d46e40b5d28abd4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 43368dd2ed3da9cd428543218e08b05ee5eb4319..0ecc42801054fb9d9cbc102a714910a0205d7534 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 256551acb690b119dd7cba15980fcd55ed5af929..71171f65df6fa30dad604ecbefb7b0cb728fcee3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c5995b20d8ebcee33acf8f3726692d57c580a4d..70aff7eeb9416cfc3eae57c9e255e2b95df6b9ca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0abbe289d01b61df22d920540d1610c4c2c2b0ad..f6d6961f8c71b20f108bf624179c00d256909424 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77622669406e98d16fa8b334c5fbb5d2c1beff0b..34e833bca36b4275c1cd18d8ffdccfd91c4ca39a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6139e082216550a1903bef186340e40d98a8c389..f7ce7f06add92f6f82afe85c3feb9a55692a02d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae327a4f277e9fd045f3c3971b7f7d7a91dd5bda..9cca1e019305fad99e644867a89d39a61fd51b71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25cf10669bb03f2f171e685c67054dd5cc8e2c7b..d2a800ed6c759ba68cbcad308835e61d572b18e6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 186dd503fea7b19fa22207b2acb3196d768bccde..7adb3c4ccdf20e1d807be8e0853a070763204cba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0108c35a3f0230988540184eeb071cef90f79bcc..24fd4e40c694d259b02feaec4475c1f260c8474e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d39b37d7df65bd932d97dbeb30bd1506a2cefd5e..1082ef53982271f711548818e936db9606f4c626 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28f678e4a063434fbbed0763d3ba54fa49fff189..78ff0f476d6ccc81a5547e35051dc721add28e32 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db7de8ee234f331646409732f536fb005a00120b..dad79ea9c87dfdbc48de77521c4a9e2b73a6175f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dbce5b09fbb049c75de3aa79a668e2a05575106d..9d2a01f4347b6f3fedd4cbbb2920ce7f907b53ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0adb9eaad56336e0fd7a3fab5024134d2b56e1fb..a8e8dd03371982122cf550fe69bb1d28ba6b00e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 059545056f439508b3120fc3a148550056ee43e7..548dbc1e51f7e996daa3703cfb56369a9b1cec43 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b70289826a3599163a913e2316185f140b0ce06..05679059c955c0eb5c9887fadd9dfbb5b1ce488d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d88da5cf023e73ca7522e76927461d98e8d63bc..9b7910cdbd102427b961cd1b2faee177feb2ca3e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 789de18ce19f2bff0ac7eddf7b6e16a8bfbda8ce..61e6994f9e68b9aeef1b1fd3aa6dd9bf95d9b5ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7cfff39de5c2de393e2726f74ccc49ab39d6fa07..f2ba4daaa42b3b06005c00c67542d06dfd3f25e1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5db98f861fcbd83d45853488cfb36da33e676c2c..65b77642bcd9d8fc9cb997f014844bbb343411a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad6d4f41f0896f5e059943da3ed35411876bc5d3..fd2933c449cd4b17188aab3b22d3622f449fd01a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b52266e4c39b9ba02c54c1ab069fb15d3f36c43c..4f1f46c6bed375de91dace63a75ca213834b58a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d23c3fadeab52f99a15293a84048d9c74210f8e..118d16c3d4eb006215508c9d7695fcc93984f02c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9134fbdc2123cfb718eba16da9a8ea50f731ce21..2ea612ae0ff03dbb744e46e6ef8a475c18c9a5b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2274e53a7667e4d9dc3aafc49d631672d6b01d06..cf6464b307be31b6bb792769156357d1a0d0ef34 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2267f2322e2c7e4f29fbd9031c8bbc5aa2342b20..18f4dfeccd46aadcf98015a1c79227046309ef15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c388aa822a4b35e92f79f18910737c448fe0873..ea9c76230a30db5525ff20b07b62dda5d23d6b48 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b43503f0be79a7365feeceade74d400255bd128..3c7ec641550cd46e723aee07bfddb6e28ecc903b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f575f7b889b34b3b92ea0ea34cd24082746712f7..0894d459d9f14fabaff7002c88d7cc12d8a6f44c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2176f646d978950b4d353a8f26883d5e00b2f68..cfa2f637bd4722b8e277df941a08a747edde888a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6b53735b27097bed9c2be77c4e172f1a2a5cfbd..89e46bc3d4c14b0d92b751cd028751a365cad5cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91457c9fd7a2af3b246962bb6dcb8277514152db..3d7ff971107c0a72a657c0c5ff546d21e79c00f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index adfe27d5c60ed475332532fd0f73d66755fae9c0..e4ad7a8fa9030bfe1fb6668b1e88841f719cebd0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d572582e48d57070bc56a165cacbfe1180107324..d8951cfac4bb7b8d659a1b007b51511fef89069e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab08a6ba69db798e3399a582357b776ad9c8dced..ccd7888ed6f7fefd45bc88e7b31448a731ab2a27 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1cc009da612145f1b8f881be994f0fd944891d90..7b32322f2e89e84e8a6758425343524f97c131e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5ff23a69c155212e73804aa08607a33960c27a4..b681f6e7f0990a39b9da7cfc98135ff77c653d3e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79aeb8e3ee806c0b370972dbf96c0f5ad671e3fe..82548850074eb8f99368532b19b9db23a0d4f7f1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b9feba4543bf055d2b77120263101ea261b1e7f..0413bee54d812717700f981912790e74835034a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ef8a1dad8ebbfa14a39ae021b083c8f73369c14..35984eb7af7abc485fdd2112a1dc57d326dd25c8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04ddcf67ea131610c17ac61397bb675aea24367f..69ceeeda321aa842eab1746c58b3bc2017046eb8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2be7fad2be0dd95eefc397847e16029c98d08c78..c29d34e3f30bdb7d526d55063ae459821ddd1974 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019-2016 by the deal.II authors
+// Copyright (C) 2015 - 2020-2016 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 392a919588c8d75d36f513c17d8857710b673fd4..395819b46faf942811d04659a3e976cb6b293852 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f74fff16621b1abf21b75f552eea7d18f75788c..56e586e10c83b06d62b75e0e0dc568353b63b77c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5fd5337054efeff02190851339fc69b9c5177cd7..29229245dfe8116d5539b486f13f6d9059e14d90 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2019 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d10c9fe1a37c8fba265a31e1db5a852b0339a6c3..39409a85cbc83b2f0ba04e5224b4901cd1f38d97 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e8435e5e20f6bc84682ea8e67a04de7138200a3..29f08970d3a5eab0f918b17162ed91673e3a78f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ef873e6c6d0b37f111d1ddb0bb3479df5c44195..145fb7777512c49309656b5078e2258cc43bbbc7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a9994b124721e547061e4cd3edfe49144a5379db..45af42ad6ee5f65628112e90abe0e050fcacd312 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75a143dc94061dfaa02d0926aa157f67fca203c2..f3885152c9bc4a5636496a5d46dcf5082fd4d775 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34e497774f4369ac68773cf07f7b6734c913b858..072d3db715d71597116667dd440abfee29b14324 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68b5d9ed8b13d36fa996eb74c595081c5f532c46..057e4f902230de9af3be7bfa98d975233a377806 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb84ec56b3751d5f7c3f6941b1916bf2be2d2a29..6a9571cbf0faa5e3d214176877f1f1f4369ffc9a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee8b8011a0ea4e88dbc0ee305c667ed2f72ea331..6f70bca73505dfff961b14972c385ea4b9430ee5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0f65ac3c167ba50cf36efd1b0a8e8137a25872aa..89857bf07b0758b21f26a7adfb42f820aab328c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5e6f925ac5d057c814b966aba5213da5904dbdb..9636e89cbf7703e3e9e30fb17e6d1b11582efd36 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 828fcf2657702d9ac8349d74e422d40563006c62..c1607aca1724bd03cb2f2187325bb7b0985c2cff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5706b693386ea437b2b45565206df95892b1937c..3d39a3b5823fad2d4fc0782e359f8e7ec96d02bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5483a2460d3904c678d0ccf4fc8a8c87093860d9..040c73be1ba775b8abdaf3c15e44860e587c3bf9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5d44bb6ff94a2882d3445e166cbc70e7d8055ab1..b74393a1123c36c948ef5ff7b872fa249fb123f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca7523e687fda7d750154bcd915e5a70bd09498f..07c5c2db919898d5645a2707644f924f41db24e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66b721b9e9149ae721e6ff0ef688e81ddda123f7..823c670c2cf8f884d3bff4385b9dbc9e74855622 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7158255a20dea85660b4f4aa830ae35538eb66a3..35801674c26c430ff0adfa28dcc12913729bceef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb1d17b84daca0161beffc2947033b5b6561b98c..162ff1fd83e280779cefbe1d345f0d90f29c2741 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 653901aec5f973114eeb749f0cfbb2c03c1eaa5e..d7480329e8b47376c66926575ab2ccc8a0d7e4b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c29963d3421bf22c60ff150dc02d9a6fd60a677..ee6a40b3b2de503fd48f6c74c6feb772a5c376cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f448489828ad8f83d59eed6a64d99d36027a1f7..9f78c3e6151df7826aae1ff21a49ca8ee09cdb6e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e360cbe3c494bd716203ead5b9a5d1ae27f02e41..328516835bfffefffcff83996fa54ce332e6916c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 820183bef30dea526bcc29e86d88c370ae8ad177..3308faa0a08a6d29bcc61bf735dd66e76199e21f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cb8f7e930dae40999d986cdad65ecca9e2ecc54..5eb443b2a1bea93d22d2a28b1622ac54ab4cb358 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80bf1dedbd04fd8e0bd84c271edb825c9508e42e..2803327228326158407924582f08a5dc044f3c96 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37711fa4bfeed1c0a396c1a57186392e78a272a0..fe02381edfd75b6c4f0e18cead393ae0754666e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf956ea9b1d7cdef91a532f151474747f72dc02a..9002dc808e5b351767c2aa19e606b9b9d41179c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 343b52318728329751929e29b934391bd5956361..c95b745ed73be548889d37cd43458ecd26220e39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 72567d048611ce7549d0bb9206e605016d3c196f..af08c35432ff2175c1d8c0e88618e17457f42a50 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0211284cd483870c7e051200a2e4aa684faa37c..24f7e8b05b7af8b134cc61613f6c33384191a3f1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9dfe66aaf5620c2d9e392f23bd0c86a76be5b75..a9260b201683d79942407ef78a3121d05d9fea0e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ddf8a3c455d629c0637888ce37d7a91a58aee57..41aedb7a48a8f0c75aaccac229d31cf24f15d068 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2922854419728a44a5b0bca1fd183d4200ffc14a..4c2a6112e4a90779e2c7d4cd22e35632260fa430 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9081291c724c0832bfcfaa43080d71efb2dd90b..8378d6bcce727f2e6d55684e47e1ac714a83f2dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ca18f75b377d058376e1be61a81e7c125a37ef7..c0d7868547507d85aa6c4ea35744bb8ea7e6c88b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c13cc8640c91d75c3ba93dfb217265ac071689e..2681f1f36742ca4567e9c06b0c424ab8846ffa24 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 176e3ceeb43b890c64a680e259301eaa8aee7da7..030d31108b679f15dce4c679bb0085d0034b3d05 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 605313d40464857418f1cf13c2b40d1ed9dca66a..294d74a9bf7aec49049117707e88a3057bc1c2ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b64f5d673a4ec38505dc0cbe725441b12656044..8e958ab1e2e159fe5b0808ed1d3db4898f14838e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2be070749147f79afed0aec2713ef7fec521ed51..5c2c62620c00561d24ce56d77d8da872264f6418 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96d6286d1f85f88801933db0f69465936fd2eb84..d684ab304b7d96e8f841189b49b0c0836f2afd43 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2dd2915107955f95a91b3a2b1a9b36625298284..1599ea16110c1470a3c26932f2fb5b50af5e46e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94f0bc527877df69612ded25a9ce1a2ebc3999d1..e4f27720e16a166d9fee940bb550c979012c4702 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f2438167957184f215815e671f5fc2d9b3ea801..13ac6b5d06ba5dd18045d8908769050124a3e94f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8636f0f50c9dfa0efba4007f033c86f9b6856b3c..014f419920b24ad86b886dcdb846c5cc9c63de79 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f4c585f10da9a7f93d39a528d18e5eacff6e76a..dcc6529d2eff6c810376038572e1de20f1f4ba7b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 217ae6f2420ccc8f7d436b19cf4e95ffcc1a2465..6ecbcdf29200d67432d29ef2989fa74af9fe93f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9df94ede28b56a553bc9d0a5a32373739bbf0fa5..b53b2bc314f1bec45327c8cee1586f5dc14fb186 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce9327d682ee70abaac4d47ad5e8f8caf4f81bec..df434752daac703c25be17c9c03c769f22bb854b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e31172d16bbf106e1b5142ba126d6a4ae49ea40..7a249c7c6901092b538043d4b02b791be0939d0c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a41f9e666cff41cc3a1b4bcd5af61346383b71d..00b2f3f19f1617434802da4bca6445183e06604c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4427698ade6c84f4af8b41e7e489cda4b227287d..db2721f1b3b2a5d3c8bf2c23716e48a79d43beed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index faaac4e085197c1a7fed54853ba31e828ebd96c7..6201082ce371abfd33cf71ce1d1270a1d1888d13 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c88346f02801caa10c519ef745e78b7cf90f62cd..c3325ca598c80300038b3db646c197df3256434a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 73d88095b41c27ca887b87e4f54e3b5238154032..30b93d487caf50be422096456b41e2734b6ddf57 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 542bf4d6b2433c5e4bb6f7919f762f134af943df..9e4d90a0c97398e7de37c87f8af845326c9ac4ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ae0196dbbd6f8b00f3b23e33c657f1b41098e6c..9a764238edc6cb0ef7e5aee68cc9f581a3d8b430 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2019 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d639ccee405c3ff6a8faf932038d2b0254d825fa..5d62238c8310b5cced8c7837029e2a1b01219288 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9a55d25f5f6379a8356d4969c9a0907b8c0beeb..cbf49bd2bfb120debec4dee41bae8191d37bb698 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4addc2e23ee5d60c3b70009c52f250fd0403a9df..6244ee7fbbe18f6fcfafa0c77487e4ddf374877e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8162de7625bc69bec43e589c84e7d2a55e3c69c9..0feef8cf96d92cb43980ba1ee3f57eb95b1f0689 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 09704eacb7c1e70039b78de897e66770ecabc879..df465891bc67c38ff9acd9a1cc2ee96fe0b09318 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 822801b991c353d2401fc815c3087756c1464379..3c8144d622edf92d40ad83451f5e5134c7c5d3d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2019 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b750e60132f2a715eb806ec09fb06ca4baba2f8..a353016e1b0f9c8497090dca4716fc75c93d0272 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 51ee681f88d8f47967769a345c051bc574507c3b..98802f4c127f080e0abe78766953cec95f794afa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a7a116cdca6f63078414d95c045a68afeda691a..c244987bc7918af0e21ab0e2d1962d41f5bc9b45 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 195f3cedbf291bb47f7a5687345c6a291d13d35d..e88bd2f74943013aff6d395f76ea42f677212992 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11eec4c166f6632bd80190b101482c35959c62cd..1c3f85b8341e765ff34cbe9de5249ef2a1cccebc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af1d2fce43f1e48f4ed5a42e6c75ea2a5d07bb6a..0f2bc7b2d9a8cd2272f7ed210e3c57a0f9cdebbc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2868c09469210d9969c6ee09096c98247383cfb0..7bc29ccc3db707e626a67d551d226eb20dc02af8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3de968ed1c2092035263c9b9e9cf606c8dec7e2..1591c710c1e948f2095f2f6564184e15269d5356 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af8bb9357a592ab63f32a9dcd055671829724765..c1f13db48aebf208f5c854880683aaae3c7294e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf86a19edd7cd1c63348c4746b497672dd21be91..39cf9bd948716163147d37118110be4fb8367a71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b32c1b2693177195ddb02bdbe5d73544bc7eb9f..80278d0856d972d32f9042255e2839715a45c91d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b1a8afdc209291c5c2b2278c4aee610283f1bd3..9c745ceba1d3dc41f5e961cc70e166b45764b667 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6641039a1047cd93934b054eb553c94fc7b4882..d038e76e711217d9979b7cb0ca08f36f40bbf5cf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c57546fa1d492421702755b2b90de26caaa9eb6c..5c44722c066a2782e89b647bd55c61d9a1214234 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a87c0d404778d47c1fcb63a8a19305e44828a9d..f6c8d55cd6b420d43b6498a14573c684da00973f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c5dec4ff4279f117db90e90f3341236a0989629e..d71c60623cc2abf42857f3968ac729dd34027704 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7c5fdcd4ab428e822e134930821a29339eb4ba34..00ad23c901556c65b70b4425a1cdc146f428f582 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a0cb93086a9569b9af365b8ef43d80404481912..388fafac800d5ec6c165db8a19a1500d2058649d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c76207edd6f94fedff0f72b8f997d06e4f1588f6..1cd9a0cf9dcc7c25c4d9f63f63be58ad924ccb7d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbac4b6e981fbff91b23fdf889890f3bd257176d..8c1ee60874dc22261bac41d69494c33b51c5f311 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9aa52089c646be6e76d3c9ba060c5a437e69f912..494cdfd082dd8c004b787f4689e259d493a61a2c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ac0c9388666d35fabfead8e1490cc1cd8d8a7c35..0cc6c4cc0e5a8c4edcf6446eead8c11724021a64 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dec545aa68f044b32f307993a0e8605426141fad..d8ed117e1ba863a2e42d48a36e0520394e7f4d36 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3289c883efd84facfdee02b11f76330ffbdcaab..5459468171e7f0a1e2b7c28eb7cd2cf30dae4898 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a18df017d6cc75fc0e57c456328bb02daee4f12..a7b31b389acece54089366ee7ee30e9dade5fb00 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81d80fb4ae4598006e4f25b4d289cb255e1ae770..0461d9ce28de8ecc6efff87c1900c213a3963270 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f8d5dca075331f1d0b2a2274da1458c8e9c16266..211fe82cca396689c69d54aa41fd0b77ab2bd587 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1163b66dd7e083480021e5eeecc1788de051aa39..8efef5955c8dd858a7685880bc48e8d05f74006a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dbc40dc337d48c8e0c6ae22e0eba8eca1e8be587..9aa74744a479348883b2db8f0409b0b582f9c1fb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0a0972ec4e71ba37dbd951933789cf6c379f751..b2a6e26ed1f5a33074771b507e2aa979e541a7b2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0401398a6d10ae5da50ac0aa5a7b27181f0afc70..b27df09ff237e6add04c641c9e07dcc0caf761ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a063ca40532add2d320a7e683f1d865a8c99122..a73101ea2064e8583bd9b9be103c3f1e71d24cb5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 26fcdbbb0ad920aaccf5cc14fe08cbb5fafbd7e1..094718a3031b986bd3daeee7e6f2f96a91c968a6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbe1450348c43112a3071022266e65343822c871..c0628720e369e64e2caacf5020f8dbc54cec4fae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd62cd2e6c8ed800fc02ea0db81cfac5142de844..f41bce71521c87e85593bb778798a53eb9487eb0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 539d91b5880774b9b5a6248f5741c56cd14402f9..dc7bee0ca27ce0b143f32a957d98cd058f13733d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fadd5516c895b6cc98c33be70a702089809be955..431d3169a4e7df09b15d78a857410d24bb0d6ecf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33788c4b5416bad26696d7b0bf3a9958ec970704..76c880dde99c961fcd36c4399c0ebda6a3c07f85 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e3c4f097d1eef5f5360c462fbb18ce766568731..d659f1e89ac76fae01ff0425f42f018c9d5c1ef3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32bcb13c9acbc287bd9eca157b6a851a3020647f..45f361d822721ff6815fe874c7f5df0d8906cbbc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 185164c2f865f5fd18208ea6bfc0195e1a75ad0a..f61dee5d44dc0e3c1ddb47af365e9550172b657e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14a8bc559951ed2608e623980041dddb6aa9d8dc..f38c9e5222537ee6e77ddb02b156be250db9d700 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9af01c541c162ddedb486bafb1c1d481111aa097..30ea3b79a2ec194f43c199af3d40f74727732c2e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f88ebfba2ebeae3ae32230dbb02e0e7acc7e85a..b74fb5d1b54d69e0d868ee27e9417c85d5230772 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ba4e3d8f308ecfa09b32587dd2265a0932e22c2..7a567bcbad058c80e0d08f21675c39b7618ff0c2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 855e3aecb9d66eb423cf803161ac7f028b27a0a9..8e4510708bbe06b573a5f80881718528ebe30dca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 49805adfc452b7ea89486f2d63bc2fc85028ff73..878b8fe7d41e71128ff65f08acef6f654bedbe8e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 09c232a0386d6bc06cb0b3d5d9e110c9bd2fa957..11d5419d83a9e16e7f25fe2370a70f80b428b681 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2017 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5e9d85cdc6320c1c980e6434a44cae7c187d1b5..1772d1d345348834e94564d17e71667bc4dd0180 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2017 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0dcb69fc8838087d8c1384acb7635dfaee0fcb16..c7752454935066ed6aa4d74af4c94e1e8f22d6c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d88a312c3e48520a3826e9a2faa94d061cfbaf6..d2a6dcf6698a5af305faeaa5be7484351d889e45 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 875785d3334209a24d67a877ac2d6ae3494bff4e..a3057fdfa96137b06b26fd9c04bef21ec6f8c5ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 402956ac1f9d1a14ca7050b30c0d1eb58a58b508..28ef2f30e4188d9807ed7ad684229be680346c1c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc3f7c63e303c0da6aa2447e10c2ed153661d819..c5d93c553ecc354078128ac879c493ee19ef10c9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a916bdfb739c48f864bc93b437ff719a72e48a10..c2cbdf6493e9552ed1c9c7ac1843a383758f7d7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab82c4c5988c83dbc5c69a8a63cc506139c62b7c..f011253c4663f68e3cf641a3020c07525956b4ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e231bb85845281d35904128184ca16f06d685ba0..bade75be1baac4d9b47b843df17dbde07a2c004d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c154cc04d2084aa2783b00bdc5255d896a2a63e2..64f7dbe8fb8fadc91bd94c1a15e493df3ed404d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2017 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a249f795ec30df873b975de408d23a0a2f0dd62f..5e40325b9d1f901247502ad2c089e820a5e7a670 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68b171e9f5bc8b0d7cffb6e80c06428adb2dc9aa..5a8c837b0cffd337ab90db6f069eace4bb05ea16 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 53a1d912f2197f8a88ac42046214645f44c3bd9c..09df2776a9be834da526df718a6d0e6e8791b14c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f59e2066026f98ca78b92d28e8532cbc5d53d36..b79fbd1e52f31a33d153df28160fdd512ccd2599 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 500119af06dec319abeecb13663725b06789adf2..df69d3aefecaa78eddd2ceddcea46d646bfd17e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 408f3fcc4b4f1d70a129a0bec84503d5b2b46064..01535099326fe47271e115ffac407601f342d821 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48f2a9dbff06e6225b42a338c331f2dd3878f646..ac383017392456cd0df2f5546d45e226132d5d1d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b67981a8eb3a823c30023bd1388582a17dbc508..94618725c0f06de9db49edb7aa863e5c25ac6207 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 223964090f07f1c3c84bd31d6a0bec5422c5bf22..ac530dcaefb4034994731070f2f53e0d355f623a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e69e5507c23ca5ce75f76e81dbe077cd191de00a..f772d98feafd72f7bd8a284672f920774e0a91f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35286320ed4209dd6eab7047b5f65d7dada3cc5f..408697fa45eddad5a00804f83fe87a1e87eee00f 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 - 2019 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 549dd51eeb429a236782d19ded4f53500a484b6d..02d654e2cea9f5e36e92511c1efd7522a7d74415 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 - 2019 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index fc1fb78bcf38b27ffbb8ce2cee6994e8141432fc..4fad668684aed79bbac7f155573715342970265d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f0275797aaea1120ad6d0460f3dde92025a6b5c..aabf8eee29b3cfbe37d391a9283435eea86aaba5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59eff734ea9605628600bd33fbd469f178a9ba90..0cd5171bdf224a773c45724e0cbb9f891f849260 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5948e78f5e8e263e42735b1c06d9dd73977fe744..f8af400723ef14fe36bd86de4cb3a9b2ce6fc176 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60b775bd902ef86f5ecc22c8640d33eef8ada62a..4689e191f2061b439348a3bc3f574f9c5fa3bc8c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6881f97cf68f9809fd8428064087474ac828ff95..080375d2f46b3d5d96e6146d7aa9bb3a49b9eb20 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 69fde97c399fea30a723f1461bfc132146b5bd8e..058c11646ed16bda743f921f9d2f326a1891c325 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2017 - 2019 by the deal.II authors
+//    Copyright (C) 2017 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 24a9339c1c2335be036d9ae9de84f0d85caae1f3..9e3e062655501f174e00e3d260b7bc9c532f4740 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2017 - 2019 by the deal.II authors
+//    Copyright (C) 2017 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 3f2444ca7a54ca92c281bb0cd3f926dfaaa798a9..c869e4e8f02c1464419151acb479e2c1fa7f6b0b 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2017 - 2018 by the deal.II authors
+//    Copyright (C) 2017 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 452fdc5f02c2156565c305f53e62d631a8dbe826..c16cdecb9e7cffa41f09b2ef36d97512ca8a9742 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 3e886332cbba9fbcfc562bbb8caae39b85d0823b..30b3191d456fa03e69cdf90a935196921ccce176 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 632d08012d50f246f5d56d38327ce52dde71c1c7..7c2a93a4c07806599de98b2cbe6c89e4909077f0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6bd928eeb52a342cd5216efe28d73e8adba13640..e35adfab5687335f27e45b5f755a22e198e6e19d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c06056170280f334778a94595a5d86921c849639..99ee9f5c4eac1012bc8f9b79f1b1d26702831ef7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1bbea79c0355b21589baeb289e46f13a685a983..371ef361a4fc5e71b483e4fff426379a5462a500 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a2623219c9a5f0b41b987c0dd346e19b6f86edf..c70b48b86a010b12cf857bf495606f1c68503b54 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2019 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 06b6aa0dc709bf71e3503194eef6d4824a61206b..cb08a2f7e19e11fecacdd21f7cdee9374fb50443 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 19e476f9b5dd7762291ffa2e52486c32d2ec2237..d410d53bc1ca727200e5cdeae055a009145a392f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50a231323ea5904a9fc2806353aaef9a8d3a0175..ded8832382807082671a071924301040d5e990d2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ffd6153984170d7f71e4d2a1e3c51fdd1fe9448..6b70f9da80dfda01ae4b4b1541c48295eed33cdc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55524adf7ca176694676c455df51b68a34a1fcd7..9b833fcb7c9c37a4357bb3ee18b637388d7e0127 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2129c4f6ea3dbb09924669d35a8b7d9042d0bb14..69e619847dce94df3099cd0a284e6733cd846e89 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23cf758ffc642f9103b8aa73b525bd725a1577a2..269aea2e59ea802e989de8f3e867bade734209ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 633c44b057375b453d16548a296d530dd68693dd..de41fa2907af60c5efa0d81ca145b9f4074c7dcf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38b23d7833255a998c887d5d7d9f00a986eb0a4a..c135143a0a34573d75318774eb6b298365284ed8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d777f9657735bd3f2660a91e6430884d57c779c1..44545adec013bcc84a6d76d220c968f21f543eb0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48230acf65441750a94a150aa0aba9ad7dc0b731..063849be274e681b978546800e4560dfd48ac7f9 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2017 - 2019 by the deal.II authors
+//    Copyright (C) 2017 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index dce5b410a6fc1ec72dba522c85700add1de23a1a..b8e3cb3080d0430689f677a0a805c7711b898fc0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 67481e13b233a92184210175ea3fc6ca7f5da20e..607c6b27340779dd74b3773b60b571bc838fc3fb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a6b1a7b9fba3905251428cb702de1adb3bcd018..eb83593939ef336ce4617840eaad20662457b8ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc9a4b90bf1f35dd75110bad7091f9bd241b8dd6..c48451c6453ade53c6fd1d91bd6e752b58be2ceb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fde08725cbb7826621527b7e089e6aef69ea7eed..2539fb41a4516126258f58c65141da611bf62b7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95e3e91d8e0b3320a69116674a2330a84f0116e8..3305f0d116e42362697ad9946eb0d3c2774aeb50 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2019 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05ad5480ec3886f5fc44ce0270a2e003299cba3f..3ade2f546d6d7933d8155c261179c9bb2364bc5c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e43d44b207da751f525f01b81f821830a457664..9eae6504c891ccc2bbbc345771182023987dc742 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fab64120bb9acfed5189720f2ed61882b18677ec..2f7aaabf80ce9cd78315b09652d829919c491ea9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38e822bc7aee1b1d3e26607bddc5cddf49fd9fcd..a9ab446d2b3bde910ce97de11e0b9a37e5637652 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4151ee85570e453282093009faf39bbb6ebd3faa..8650c4374030a8cf641cec0cfe1e67ec0cf3c4f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 952c58e41a93e18e6d8a498fe31c471fb68fb1e8..947514ea2c7d8bff92ce1890bdaacc942ee599ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef9d2c4d3f6d91044ee6ea050259d6a386e19d41..f62dbe37a553b046c3b88ec7a136e18d79637478 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52a2cd727a355258eecf2175eb55233149cc99fc..8a318be6af2e8e6e22a28111f0e0c25ae4581970 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 609b8e2741ee5b2cc0721c0f2a9e34a63c52aed9..3772704ad06d7e536c4ad375709a24c38aa5ef39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bcfc43bea093da9774b9211d2549057cff4c3d18..85fe2462970bb97340a7554f6f604c817475fe81 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf7eb51b8a82984c73f1eb0c41b03b898c6f9032..a2b92625851a6fa1cca8c92c7dcdbb43eef1a20e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f08045430970b7466556623c7d529c1e00f57cd8..be892d3e7b809eba32c89d04eeeaa6ad012d8aef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 251050d9ba427bd8d018be1d446dbab6333ef4f7..bbe0def209653c3b98636c5f759934e629c082f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2afaa63c370ae0f088b5b319653c4eb168dcd83e..a4e5df43b43d9143a89fd938b0b485d098f7c5d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa608a269776f61b4835aaffaca497e7395a8635..c6d46286977e6c8433e0d9987e129655a9d09b38 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f4a580d1fc37671b8f84ccc69ae3b9634330fca..09eb4d340266fbaca87827935d94dfc69832e2f1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d9a7aa95a6422501a41f7223eb70b952b1a748c..b2405e5828a3eba861ee1cd010eeef795a366085 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8bcde38b3f2264f7829558eb3d499ce17c19fbe9..969385448c98cf39c79b25df4669373f8a06eb85 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e73de5f02a377f3567eec771e08aa123d2926ae..f786f994cb9465b8beb8ffa4debc4af21f8ce673 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59551672c7a33b2892bc812de252db82e09d8562..dafc94047858c21c566ba3a6faf51d4fd93f216d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f452a77d2f2b8d8cb7c0a456ae8cf4428e2d01d5..a2fcb95ce5dc055d5d9b5285195b94030e21e0d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e9087eae0f46f5af8332e30aa0b7da9f60924f1..95722a4eb61a592fc8e48a9a772a7be278f7dde7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92c7ffcc3ca08d228a51bd4ae0e684ac3759dd6d..00276c377cbef252f5f8148f42c66004f2bd64c3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5a0633c446f8622ebba6b0dc5ad7d9dcf9c4877..fc662d8f30bf149bbf64b3ef15f691feafc9e08f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 658f7910c44184981cbd7033685897ab7f03656b..380ffa0af8b49ea35ac59239e7b0f29aabd2148b 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2017 - 2019 by the deal.II authors
+## Copyright (C) 2017 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 06ff3ee3af8e1b03a74cceed21a6cffc5f15930c..a16318931cfaad9b1cf887a9eeb2dee489c3e490 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 9b27ba16b2ecd8c95d508f7644f3c53b616d21f0..978c346d872f196d08410f225e001aafe7ecae2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5f5e90d42ae2fbae9c6d96f3f2e377092a314b0a..5d728a503254749783ea8f1ca82e912aa55e7704 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4438c342963e80819fdd6c3ebe13f4a7e95488c..e87fbc8a5ec9821d11608c92a219e2d917117816 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2775af5ac2c9cbfde1a9cc5de4e0492fa6b09f23..3ed69a4ed5e00a3319c70b95b7678ac963d4b31e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0fc46f4893decf9a97f45b7e768b210dc92480f..00204672eee97c331e5fce04563c77b90eb54c70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbaf79f4cc9dc7d685b10f86ae35a7ac6aa49424..c1de26ef33500e4e41a2b5885437d3036a834379 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47b14458335b2be475079cefb0bb07dc9a5049db..23ee1a7b21040baf913400686a32550dd7efd9ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2f55d35defa7f201d645ea042c3f0bc3e952f8e..636f09f175b31bfcf17d3f2355317132d6351035 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5268ec5a7c613026c6889b3177fbef554d955985..0342befbb0b91cd1956e265b0ab27a74723ba2d3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2019 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82de15623549579f2918bdebefaa34b5f6946086..ff7c033397bfe387d61584d012490150809714d7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1679cb74d067e429c406ad944851d59cda71c6b9..c6fde425b5c35e9e81f3a629663b28147aecd3a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 861531c3928dc9229f2c285db0a3af9f37f73c2f..74d1c7de861cf57d7796469f6ea70eee09a75535 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1e35cfeeff35fc8974edf3ab12ebddadf959e92..d606150afe12101d60455bb925be13737b2c5661 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2019 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec0d9623c7e99aa3521e51a6c6265dad060a1dda..0b9ce5806e3e30fa749b9a2c267e1a120a1cc6d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5202b4f720b97ea2b77cb7540aecb0b9e0546b7d..fb484c83c91dfc07d27260e8894177c57a89b677 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48713997c6a14311f744c5bf68e1026274c7bba9..5cd803fa249582a8420cdcf7b19de6461e010074 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55b3cb05932921ff826502a0827d1b2ef52ec6a2..81324d050518680cfe623928a255a491894f8dbf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42ee541349a949854177e60e4b489fd597c29630..9d572717845046a1f1a35d16fa46ce3ff789b036 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fec4898dd455eccb8e5baf2c544910e1c057bda1..9e40f700134a3e7ba0c76a5f27eb82cf0752e324 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfabdb68124b240b513c29060a8cc3ddc9ef08e0..f12c46d95a51e7cf1f1639be67a0ba2febeb7ede 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63e5dc05188721f3eb2a39c7634bd114c464a2f3..5c7f0d8f3b521595a2181acc43374adbfca9026a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cbf2896b43cfb2376bd3e308e62724cf028667b2..ce7d16e92415dbb24c7a55ad2f92454a1614f0f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f4b982564eac2ecbf7beb1cd2815949c52517c0..b2835c83f3b9325e5e9ec1dbb5918bfa6571c9f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0178308e247038c89d80168e086f537a6b71740a..7de638ae859b344a3ef387d268ed45e611575d5d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f13706cc2784c7b9db28694fa66fb00eec2d062..d8c2429bc1d0ba703da842678fb4a8beeab65c77 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cce112d35e1f2a276ff59d3f2d564ea8532c3da7..9c308b7d4321e947853b9d864413aca47a8977e6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48528622362017af39ac879881f33e983ca70ea0..a677741df6f610fca3ba4268f4f84136ad65077b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9dd9761a95ad29212321dba227be5333be7bbd7..4eacd86c356c5993968396891876f74948388a18 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index bd7fad2536653725a8b5fa028c38b54084a5b9bd..1a83b0a9c54be3ddc906d0ee6ffda4364fc10bb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c343605fe00d4bdeabced6290fe9e223709a71f4..e2fc86f4ef15fcdaa582a0b88403b58bd2267127 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb66ffec3002871aa089100b465ce64d12056cd3..97988fb0810abbc42db5020e0a502c883379525e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97113e5d36bfbdadb1dcee69579b6282d33319fa..01090ec6c5a48e749d2a1a2afb8b140a47d98a79 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db2860bf1d046058172886b2c52458afdcaf526f..60fe4045d8ca17cea17ba6d939731c32946232fe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9409a368cbdcad3dbcde5d72ad890d0d98dae91b..01fd10f4e8bf002d38b28f3254929598eebba529 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c61896fb704cd30ca8bd8b7a13f5d2ce420fc3ff..6b534e1612dc2c3183a4cc13bc29fecbe7e5303d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2019 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 818ddb0b6f4c5320d7f33f82e143c9d062dc124c..88b3081d6fa7f84ed73e2956427851aac1cd2705 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 214d86ea5b698a20d0dcbaf22479b63bf2e72da2..f958d3b41f6458ebe7e28b151be724bc40aad85e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e548282a3297fd2d060fb81b936788f35efb453a..5c1506b4b0fa48847d87db6d8de2329d14e613a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 611f20ac4ee2f91253a527efd818e83ba96aad8d..dc77242fecc0e4819f03451ecefefe7a043ed805 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b67825318314204f4fd9c5dd62c62adac60d2944..4ca5a952e504170060eff5b9386ad7e33c11d46d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c17fd45f7da3b42e5dbec2c990224cb81f83434b..6e64500a7f10850c71d4b86fd96ed73a43cf797f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d04d3e2f5205bea79eb207f03c18d65b8220d09..f92894054f18b106d432bdb096aff4237ad7cd25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13e1c27634b925bb410bda1a09766eb3ce69e850..b465eea725a92e8e1fff54e34a74700e74dba3c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ab6de7034b6b490a439b38893a6d0709700413d..25600d70416fe11d2a103f89060aaeb1b24fb2ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c883a583674823b322f6c6785d0f670eb942ac00..8d28cce37d02fa8a18159debf8839b892c4fe945 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d77f389ad5613bcb2e445d19db196e68d25629a5..d227df05fa47ba20c4dc2022492e79508be71e1d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2019 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 24d4a5714bc35a38f7e87ff03828503829778b19..fa9f6ccef90b2cda1ea8a9b566bdc617fa271ab2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3702b2ce9159a430559b28dcb1741b140a973cfd..5d085016e932a2832bf8faa2f1f5936cfbe10702 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b495c096d0c27d91d53e2bbbe0165140b818db4..344207af959d7d0b8d86cd4b150c46be0f02cebd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2aed8efd001c7f68028a4a2ac129b709621ec87b..ec657d0a6c01a7eed728a326117c74d4fd481c35 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23a3eadc8df5e6621ba41e3a8720ef44e642b915..923f59234ec7d2fa692041beb341f211b72a64df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d089635fa74e4f7157f8936730dfe442e68f612e..9a17c2aa9364b4ca06245992396c2a7a6e07e001 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ad4e9f9289b44db7e123a285c003d3b1cd041a4..a26233678f384fbc548685a2e4f988d4c35da3c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c56e6c8725b9ba0a68adbd672099011942cc44a1..6c6d291b71fe3d1dfde35e0c4505104048491eb9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2017 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80e250772034c7aac000e4c8d41ebf82f81a557c..29faa5dbd7e599bb3d88d3da1f468039742642f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d40fef3a92f326ab133d7c036e42b40a727dbc94..23e88178e8bbf6261fdb43e5a89a8d3f4dfb3d04 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7749fbb96f11ada56af6cd22f80c90d1aa345d46..a677e6b7f2819ff93fcdae3fe8b5beb9c4be636a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d00b05df834097ce1b52b52599b404e35c9eba8c..5433bf7471a06a27d7ff513c44f251dcc9d70574 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96cb9721667891c57e7478a6107b3e7f00c88780..7949dd065afcb6efbe48ff2384799275d4cadaa2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ba4ff1839c3f9932090ed44c8a5e62b6d8999a3..a11ee168ed68ea2ec032f7a3ad9e8499c9bda7df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca0483c886a294ad6f8fdfe8547497442df2b3f2..4dee93228becfe6fb7ef69cd10b6a6356800939b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfa18d4865fb284ff9d649d3874899999f9887c4..fc3cd6448616b4b34ad5cc8e1c2dc8bc48ef1832 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14c0a1f747886713e7250ed8f42be9c6b82bdb79..83e77c57529b61c7b0f1bc44b3d513a81b9896d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 031eeefbed3405b40d5ec834bdfb8d78c45d924b..062c6d14bc12232e908aba4ff6ace3fdc766e302 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2018 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index dd773fb5529e01f8fba3be2c3a505351f1ef1780..c31e8151157670b65cd38cde00d14098ad2ea90c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d350c01c4e8f3b180786727bc2c1e82bdc1d3672..6db7ae06c4fa7962afa4628f1e3f7a70e310faf9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bcfb2fb267a999d41188de7f2a3805dd31e81216..d4823940860f076eae9fca6e076cc313f1ee6052 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd361e89f24cd624eb9e65991c785253b55a98d0..e4f5d56a006005b199c0cd82e5fcf2daf13b6763 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 53cb5d3924e4cfa38a269d27c34cf0f9358acf50..cacec43d384b4298b6dadcbdf65798332274ff74 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9d843ac1ca76369840f1a86272aada9c8502255..dc59139e57e48929a2529b10c82ba5117ec034f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 641eb8eae5ff3371ba85fb64c4e83c03095768fc..e6121786395ee5d179fe3c24491eec26455e4901 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14452345cd096070f572c44da7ff4b7d8e9ad1e5..1a6ff7f790898a74ff0fcd598913a207a2211152 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0a4c0b36c5cb663658fcdfba7eca325fcb52fa8..efe49e975349e8a6ebb9352955fe887bf0c88dd6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cda5c86b8b1998ab2aebcae9f67cced48729b612..685c975582751c8e96dc6752e7da374fc4d3e5b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ac471d43702efeaffdb1876de2af784f463017f2..c08037543632c9074a30b0155aeeb9ee8bf21c75 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b3d842a878d7b03eb42596653f48d5606c93006..f9a80058068c39ef47458349fa87c601966881f8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 812bd72e458427ed1b71823d31a6c64c031bbc34..059bf89b50c50a9cdacff79cec6de31804146cbf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2d75590c91604b09cec7b5914ad376698045630..f3876fa67b8f87f2f4321521ee60474578e5ab22 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df41f41960d56fc8e521ccbe7abc70aec5390420..95c558aa7aa5ed69313c8a0b2bce75e0bbb4e163 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2019 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0515b9fbd70548ef59dba45959bd8372da0f277..ee43772c162f36752d9ea107272ecd094c32e2cd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18b49baf9b5712f49ba7a07c9d1c8f4af17863f6..e261c8b2b3a556dc5a7433186cb25e8949e11eed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4154d540ed2e3b0cb68454b36a94aea27358f5e3..0e584aef30cd1602fc32c081c29bcf1c13ed64dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2019 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4ab63eda2abe1d77799aaaf7c99abc7d6895c99..b4c6f5d713dbb3dda79bb6c41bac5b725a2608f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8cb70dbaa154889a63121c29871deba0979c554..edbe39372f8b94e933e893e4f84b0863eed6e69f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 914f13806d4334c645ae62cf0edb7089dd20befd..2c65a4a180061d6fba175756588d8a1dbbda4dd3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d1fa66f01862bfecac96be8564352ee480187f6c..3262ebab7324e41829a9e2aac0dcfe47b1ac3e64 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2017 by the deal.II authors
+## Copyright (C) 2012 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index fd9bb1d7cf76671a1fffec498ec4fad3adb6cc4b..011ed67a3b47d2c84ceedd0a69a3d701765ff061 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6187b0e9b0abc8f70a07fb8407ce871c589065e..be4e010abb9fe11c71092dbdf31e585b98554c82 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87a0ac500ad805affe1d7a88810e5b67bebf10d8..7f1929f7890f083d07cd25379dff2ace7757c0df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6fbc5e361076124aeeb202612eda9900b114a8dc..a1a5b1e1acbb07bf0f0371b44347e9adda124a29 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8683eb5ddd9a8575cdc52ff00b072774bf701689..a348115326fccee09d722e4b2c49bffe65e0cacd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 43b3ec6613ddbf4a28058822f255a36041bd420d..d48e0f8a8cf68e4c9f17a5e06b9ca04fa1e6aad8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 420a5100d1526db24bc31286977e11017289f684..07e08b9851373c87826dce168b6b0fc2b2167d7c 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2019 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index a976cb5320b95fe40c2491ad53ba8e3e4768321e..4fcb197a8a549d9e452258f7f3be1fe525d96007 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index edb74ccaec34b74e87afa9a5a4ba60c79ee31a10..1cc0392e53b948fc55270f74ed06d1b180ecd10a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ddf62f7c3d5a87603047416abd093291c5d943c..43920bd1f47822eb14ac07220e437ffd899c556f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f5cb6e7ccb742169cd37240e34772e8fd955c4f..e951790afbd96e89c783cd5945a9a971e550bfc6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c82c7bb6e584dddb9b1f83a1ead97305f4962bd0..4a9198593745d6405362686468b967d2bb509e1d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce5734f543ca0ebd5a0bd05e6b73ecd2e985c869..b0c19ccb38c136394fc813802a89a25134c5a25e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be711c7a551d5e96574671ad408c68e506e5d052..da46a8607700276928a8a5c62a0512e8260a6617 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db04cc22f4b8fccf4ebe0cec734bbcd7c2ee2e55..0b0f5ec82801bd437b920800a495730a52ed542e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e904755d2b28900288f59f8b8278cc6f95cd5186..24ffcb166b54e80b8fd4fc2b8aa15a7793d9e44a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3af36ce1c084fc911981c8e37219b1c29dfbf220..383c8d11f809787e3a599f4e68989f2ccadfb974 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b66bf5b4c1dda6be88979cc4c21514f6c073889..0651a33839ee0cf07f39df34ecbe639e2221d6a1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd770ed656844d8e32425db153783698782b0500..68c207353e62f3f93a082b6d5813aa2e4c6c93ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfefd82cf5bae159f158b9e9f2b79242f800d6d9..8ef6624eeb61191026859dabea2137e8fd98ebc7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3ffb4cda16291ff7ae013228d06ca47635ef506..ca8ddaf97ac151a5a5a93f0cd0c6434665a3fcfc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc47a6f9aeb218c8617eadc3fd16453d9d9c531e..75608c295348aaa4296bf235d56f2d52dcd936e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66fd754fc66dd86f70c02e7ae3fe99a5e5a189d8..b031eebc921a58dc179b7ec4579e917ad63793c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b152cfae59aae86ea87adf2ffc04bea31ba5c273..87fe77232687f0132b4730e3c0fa8c4057ea418d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 166e46883e40f9c880bd4c1ec693c8b8d2658ae2..f1b856be34f5399287c7b5f03e632479fd97f294 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef46e7c30c4220bb07c195be9db0f15ba67289eb..44a3232fbc5352c44a6f49772fe71ebefb19efa2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7aceed174cdd1449e69c651cebb2c0c95650e8c2..4e4d148655efd7183c5b68050cacdfb420f0afe1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b2c83187db1ffa35d908822d41a5a95526533bf..a9ec4270bd7d41ef0fcd729618aa2bbf53b5bf60 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 031878cd0026dc1c772572ab966ab333ef7af713..8f0433cc638970a1a7aa8a1e5029f6d4fa0cf777 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70349aaa06495be622dec2a5ed675fc123dcd51a..bd6b591eb9bc87156d88c26abfc0fbcc95562d3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cf2f2ca94146515e7218ee2c8e38c4cc822d480..af0451586d963559fc81eaf276660029587cfffd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2411604796f632f4200e1a7eb3a9ae6345edd7bc..80d5fa436804826d0b4eff85150dbba51b586e5a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd10f6a7815473755beed38f6d3fdb03ddcac157..b24f8a395953a30cb5e14ac1147ab6ff1894e2b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index acaf840ed40a9f65738adf9b729327eb26077bab..b04542484f3ba6b57de0ea6d25675591718c5121 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16a392ed9cf14701070923e6361c77029a486457..f8592dce67bdd3e123e5b62aa4b24aac8a31cbd8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1518885796710052971ecb90ac048a6d30965202..b694953bb009b777ce7d4e2e7bd3eb44db7c07ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc2adefaae3106d99e694fef956f151af9953f0e..f1faa15f15001e15369cbc66a72820194c6f0a77 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 408f32af22cfeb0e9dd4240675bd8c838f103d0a..83e7133891d23c0b0530cbf499d4cdef81865478 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10267c097656248502dfc131685deb48e8f83dba..99346c517d79d9ad6d91676b8baaff7a5dc721a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c1bb8aeac0ea5524eed73baefbab1e6bc71203d..e0d5976dccaf5489ac6fc507c0d868d9d74030fd 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2013 - 2018 by the deal.II authors
+## Copyright (C) 2013 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 83d8b197e9664c6edea4b9fd7f1132c7a4fed848..35fafd4f92949d94ec5deb75df71c790b1dba252 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe47a54bb71e4a84318d62a2fc6c817041e14f65..7b3996bf0b9bc67c882a954c9c51aae29ee473ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f0e9a153a4698610f0be9819475baaf13662c34..5f50a9951c340c25e3e5de5b6bbdd6fea0ebca4f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 53c7631a99a817ca09b578e9bfa1786e00f2efaa..f143a61fc904e6a51880c54835ecd521e449aa93 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c45ce9100f884f7cc50cf567de85389a8284dd4a..7125afaf212f1ddfbffb55110cde9fe75e64ebd7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 200791ed24223e36e45b5d7ade3401b6c5eeb1ac..46056b89ba48631619bafd3da39fd616396f439c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db089eaabe26529a5e67fab4883baac7e21358b6..8dd388dc8ebe4a5344d9b7668552a0f91f206768 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9dac385c6382b38e9e873cce0508635fb94d2c1b..f82fdd968212e924f14b097aaa4b975d9d739703 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1252193fb3228a23cfb7c0aaed1829569a3f1ee..c1f1152488e0970bb627fddc3e12f4d26440c8db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6fd4de1c7fa2b2b80b7771c98f4955741b2489e..774399cffae414c2d10fc19af00f3fb79651a203 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d14e8adb6b3f828ee16f4b939b9877f998d6d82..920d11027e39da46e619966bb98636612751e302 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 588566712b2707fc753afaef0a9dc5b58166d2cc..a58b25751fd564069b5fb18262d2eddb0b537b8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 156b170073fc18e95212feb9682361098c0a9880..129872a8cae2b2853f78f6bdb1ee76564139ded9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ba4c140d0b2df7be3ef6d2eeaa6336ec1762d7f..0366c67cc7541eecf5800651202d05b527b896d5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0c8841afbff8e9c7ac66cca5f00f47408efeb757..eb4385980ed98ce53f7a046356367dbc5616fe33 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2849142472ab7532355867d45b1417e152150079..c8fbafefb3eb4b6f04a9aef0f1b396f1cc347ea3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70e8e398d4cde56fd5d3c1a8a3dedd3bd63e6143..654236c4013c2c3b5996d15173f3dcd00bf5be49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cafcc608a0bbbd030d140eabe0d0b9414db2145e..f825afdf3f001a3db4fd132b798b769b4e3d3798 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77842e8aaba31bc161c8d533af7d1300a650876a..1e51506b1751b4e489a023a21af5241bc9a08844 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d9ccbb32a9afc76dde191d942fd6c21a3cdfa45..8ea4a0eb48d8f22646dbaa476556540ed7955838 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2018 by the deal.II authors
+## Copyright (C) 2012 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 93bb108b8c17e5e16e0a1a589b66fb8e9595ae19..cd1306b1a09bf195d00d8792abac32d3f29ff330 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 83f484ff2b92f4515e496a5648b0509d2447c573..25daf080c09b0915a3826ea4339aac97f4a3bd7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e3e9eb1863c773571a19e1a87e038a0e64e22b73..9a9494c928f31fcfe9ba91c5c565f09b73daefd8 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2012 - 2018 by the deal.II authors
+## Copyright (C) 2012 - 2019 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 39b1545239161abec140f211918e4b2814c7f860..f35b6bbc88a50fdd433d05aad57ae2199786f970 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a48923f3cb500b5c99f350670359c48e15158f56..6e4b8d8307bd3189cdf3b597d305de720c0b8d4c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e40bda2f1bad17a05e7a12e7901240aa25872d1b..52118e7a8644015aadf28d3a4174ce65b51b5892 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25842ab1afb73f75dbea26a5844eaf96c931d86a..39b4877139013809c5ae3e74343434a73e00eb50 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68b1a94b6b779f900d4f3ab716ffbb06a5dcaec0..9f01816b4cb766027b7be081ed02021171366f5c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa59e3f5081f80f5a78a238a34d425b2da663caa..d812572042bfced41140f0451e49494f83ef984d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ffe169699320bf8376f68f78c00d28450bbcee99..e8f6227a54d42f128062bfb15e0c2e7f84cf403b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd134c67d2b884298087c6fcecfa4f74f1c5d3de..bba7cf72427acc1b41fa6d6ca3edf8fc2643e930 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2019 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87b2e313bb05a34203ec63631a52acd8824d1f12..f07c789dc6c267e14cd4bc14155503d45b29f111 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a8f7331bfa7ac3a3bedf9b8e175a827f4180942..9ceff18af66c104892adb4fed320b1ebeb6992fe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2019 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a07eb0ae6385ece6219461cd975b5c3e313eb1b2..2177613d008afee1e96f0fbd71d641c11fcd8bcc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2017 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d387d0bccddc00148ab77c3f6e73a0ed16fd1ce3..fc0997629ff9dfe74efb7e0aba23f81ea48369d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85779dcfcd4e58e09d54c59fb04a937254dced88..6b8a19466909a84a91bc03afe22bf1b7cda4d30f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e5494bd213eb794e91900010f9db7b1b5617fc4..cf945e4146d9f3501e84584ac18e9f13d077e135 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21884e2f9e26fe1a56f197e2c4e8cc5bf90c9b20..93ae1d2338e76a1abd57bee8ac82cf2a48ccbc24 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba7e51cd5e01f124f513da9ed5517e78a0ca83c5..fb6d2c1228fcacad900f3fcceea45f5c82b943f0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4c1f15f29aea133f30bdfe6cf93a304451e284e..a979dfab761fad12e621666ed3ad449c3ac1e18d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2017 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 436b8667ea3b8e9486395ca05276298c0a1a1695..9b1ac663e3fb3d47719fd66339ca870c5cab22b1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2015 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98fcb9308da187ef68975e14c45310c7a35dd918..a51277e2046277befa1c2fc2970c28b4285277d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2014 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d96f198b7b6f964e40c1c6985221d4d91d27d45e..f254ea50dd88d8c6eabbd1e9b12b92c28f7eb64e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52da94895f7a79a0147ea03e4c73a2b1944b36cd..ec51e470a5f6acba6037e3040a1f109c2cc4e14c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e3588cbb2cc78dda83a9b1b59a312342466c8af3..f0c81814631843c7077737b07727006003a669c8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2afe935448c8e4054b60d242010caedb8b30904d..10d0b78cbed847ea771e8793256c45eeef2b26f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cebb158350c094996e74deec5e5d7b3cc4424f67..079b66fa97ec29ffd07d8fa862ede1baf69be94a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 08699b2c64a0f081269b3ac08f3a1a5e670fda1b..06c6bdecb8dcb279a10378dd475b744e662b668d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42030ada21f8f424362c3b10f15eb849c35016c5..37687c3ab04cc0059d0cdb175e6c779c69bcd680 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2468ae15f29ca38d3c1a6100c420c803444aa76..b9f11d79b94addcdc28511a4164792ab446d822a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71dbc91ec8a42a75877c70df76551c9af3c85b40..ce0c4f38c945da7df2e639cc604e243e64576461 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2017 by the deal.II authors
+## Copyright (C) 2017 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 97d72c4f2e5897e3e2ee3b97a8ed1abc68ed6446..b359db11b013a78f187fa4e699876d1fbe06d53f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7bcff62eb102a2b6233d2a9edf514b3f5445a9f0..5b5961480c5e52de2e2f25d1c8c46bf43132ddff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1dfb5ec3d6e5c64f9c00d1cf690d6665ab2de06..c00c41abddd0b3656faa6c65c6e1039602ccd60d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7045add9bfc423426b97f87853ebda84074c2e2e..5773db6dc1cf57aa64ff2996e39cfc96ea414e58 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8f98e152c7be49030f69293c355316668aae3ff..5a75bb99cd4922997c2f8d72e127039be6f4a2c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc0378ca7bb5056afa7f04e198dcbcd6ebd95965..cec5de071f87d6911ae5fb158e1c7547dd5b43c7 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2017 - 2019 by the deal.II authors
+//    Copyright (C) 2017 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index a44f7326589d1af071a82289e439a91fc2a86617..ef5397a9df7f110cf9a0c1b81f046fd9a0ff918e 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2015 - 2019 by the deal.II authors
+//    Copyright (C) 2015 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index a3d9f5612303f4ca470957e893aec17122ff44f7..c463bdea41e169a6772d6b9262d527f0489139e1 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2017 - 2018 by the deal.II authors
+//    Copyright (C) 2017 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 45772a695e7dc5f39f7b805f97b08d22b5800cbb..8c9c499da20be1f5f2dd08be35b88e9151a2a574 100644 (file)
@@ -1,6 +1,6 @@
 ## ---------------------------------------------------------------------
 ##
-## Copyright (C) 2013 - 2018 by the deal.II authors
+## Copyright (C) 2013 - 2020 by the deal.II authors
 ##
 ## This file is part of the deal.II library.
 ##
index 4e5a589aa9af2ff839a0acbf2a87d7206fc50d36..c6185076fd3939f6dbc09db9a184fcd889e8003b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f49b3108f2d74f28bca31769d380bc8c4b57bc1..447a06cbcdb3e102cc75b93f25dc2e4a0b970333 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ebd10123eaa3ed6c99f1d227103427ec8043b5c8..fbd91323cc14a5f54184601c670cbb060e1998df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11bba49e924af469a8851d243ea5d90504ce93ea..8a432352f9aa032ae50f720e451d9288b4168735 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 46433c61e5c90affbfd00abdd61e6d61b6aad02a..430f9fab5872a9fb10031728c42758576fd3ab46 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57d25dded888602e255618e670cc49c164948a69..bb3cfa849b5edc9b6a453bd67d7819deeb92b97a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 362a1ebf77769da897ba17be6df726f0b818eb0e..9bfcaea68de5c34a3430e468aa0b76d6ffacf975 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a17ee71b2c83aeb5d95c06caab00c49552268116..3a1a928c5adf2c98d73eb097d6d44400e0ecb3e1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b1163e93998c5dd1c8d5ed70ae8f96528f41de1b..d1859321dc8076536dc25798cecfdb67d43ee204 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f8afd51b7e6c334b887c9a3279c65e5c9164936..9333093d3c0f9d875c47577c3043c93764d6373b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82ba8d0483e855522de1d284034704ee21ba687e..567b74a649cf34af1b044f0634196116fe9759a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cbc84398fb7aea6b542b4939696c0ef4d9299866..41d37c9f197eb80e34bc4f895d7b7be7285483fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a670dd1f28a9fa42c95853571601faab7eb5ac68..1d9c450a13997111c16e969d6f5bb5e9f27b57ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8e548fb06061bc14f8ed3f8742db0cd9b750f4b7..34661693da4815afc0fffa4318dd065aeef55f3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e22801a9d490f98760a850d137f58a569ff44d0..11d16322f2f1bba852d69062b6749ebe1eb780d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be6ac3223319f409065edb4cce5e30242e7604b0..a95c4bb2a1f4f954c05ac3b54ad9a164240c2feb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 958cd4972e24077685bed66eda90c841498cb646..fba99f1549a95f75161c9fdd0c6177b2a72ef20d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b49db6a96a9ad7277b427b488f015b63fd43362f..43ce745d5ede1d869d005a2210b4ac256970c24d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b332267238a5ac5bb9ae7681dc24325b1d4433a0..4ce3c01ba59b5243882b436f2f5197a12b85a35c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc03205372d4cc4184c970666c06bae464b811ba..ffb9a8584e978ac748f5eeaefed288216abb234b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3897cfda1428a131106004a379f5e4fbca03c0fa..4581e4f55064fbc46a42df700f740162006a06d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d0412fe3eca6d0210eb9e2b815748e1d04a389f..cb67d507d628365dad0bd3d901b03cdb40cb0fde 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25cb6e95aaab49dd3a5c088f7b67f668f4acdffe..32472e508ee4351feae140b2a27b1fa6eb118bf0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 908a8613ba27cb44e65c47821f9fa8f1e4e7e0b2..c45248e11ba63d83604d319375767a6f1558354b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 807e652ad2961cb46c04b27d87b4f9ed3fa912cb..235d350314ba9ac482ab4815565b3d45030231be 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94293bbb1f556417b15969a324f8fc181d3ae4dd..4a8d13570f0193e9db166dc0ba3232c681df02e7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a7e66fd2d36c80e809865a0cf00b68f353c1b319..fe0dea4bf3b03d03310913449d8b35dc287fff24 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3de0d41baa7df00f915ee0b714176b6719f7ab0a..2d150e47af3b71d1178b35f03b5015848cb69ebe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 29ea11c80ab4fdb164b32dc733966a18c5c75bdc..d6d013c061024dfb1dd0bc79858fc585e2b2ec3c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87b82c3c5da02f48ace137cc36cac17f4a96b17f..06026b1dc018996a74ac9c65bd093a31bea2fff6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85883de9a9fcb3151899337ed1a625753b7aefe0..57d172dfb4eac57e18cb2886da896abb5d6cdcf5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ca6cfca2610c6a624f9751611a0fd5abe1b9afb..a4da1168858cf2723e0d6688e0cd8954a7f3f2ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d64014a1e0f24d16fca9c68128a6d354ad3d3fdb..7d3a85bb9b263daa9d0056ceb6a01c8cb15ea3d7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 69053b7743bb6772ff4a0a22d8be078d151b2ab9..3798b18b33b991f79931d84fbf89733f1f2ea84e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 568367b90bb018a58bff18b1e0cac332e84c46d3..990ced5833982a91ccf458ef06a60b3434e8bca5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c490cfe4b6f2efd78d34085708cc4efe7d21bacb..c123749a55a8cd79c96d173989784be6a082efea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7bfb8c75d591464e45ded5e0b9ff5fae1a08415e..64db8b3dcad3e4a47b6e71f47852a71128d651f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c83da3e252d949e1f3f36c041dc00572bca6a5a..b0d093ea33d32990934f7b8b7d5e583fdaabda5f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 244461332dc6f95bc55e48a34a5ba5a5d19752f9..97e746a304623b3c3d96c5d316adcaf1d1858cae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d76b33a359e801c140edc700c4b5d6c0f3cab2c..84fd73670a92dad5cdb56336f14892adf2188dbb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d5b7e4ae4544c9c2096ee3e5db29962667c044a..5a3cd0e154ce3562215ab69c2d24136c933c5681 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a3fac23757dd86b7847e23b7cc6840ec365077e..50d7f3bf4714cf651b25d3c4942c29ae755c2a6f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee5febd6cc9ecea24dc73a4b82202b0ca5913ef6..1b78d134905ef096795c0878cc8444ca1466e74a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2cfc296bdcb0f4a285c163f83136cdde3c4fe02..c7d582a1f242411587ea3140ecd6262a0d7dbcc0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 590f2390f0927ef4b63d45711d3049e30b42855d..f111d85273fb505649f51bc14a526a5421c782ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0cd1a3d285bee3d5f86bfa9d040188b140fa348e..eec00ecee97c62dfe3b37265acc37c842d471741 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aab22db34489b36726e1a342d2474007224f27ec..a096e90e0610288c5010d67614102740bb1d0625 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35979ac1230021816fc102624b537f6304cb2ed1..53632152216a96130463e670d16d75e07dd9b091 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aff7b91fabd37b2514ef7dd15b0ac90613e61a51..8a97db651fd4da989458f3b37c5252be0d50660d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f4ed95e9b2cdb1515e8e56df667ce2ae8dfa84d..6b8438f233af5f046f1602426059b62202378370 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f57fb351329684cccafbd672f5e1ed721eb8a50..1550252d573db3a3df243db4ad4954fae4643cce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0f86b2d8999d0b94e92029ad7c64bf6f9b3d41d..e1e758ae5beac0f90f32b2c0106b84e05cffd27a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1a1bfd7b7bf8ab0c571af29c9f7a483c528977e..38157edc3908f472e6a934e4e201723c3c193ff9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 700e5e31da7f5fbf0f6264e9fc65d83528038c6b..a3a3511e4dd59244b26ee588b65bc940699dcfef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 309a4ae06df3f355a3220067811541f417ac68c7..d22f087043370d9c774df4ad8a4c66fd3d567e85 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93ae6f99cbaf8000ced01bf8055d62525069f3f3..2088524745e3cbc4178366e9620f64c4e801fcbb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 085d786796679c2d97d18085d4e26732d9ec7aa0..3c858efc0632c426ca38ae29a91e962373e61f31 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index efe9ed0a09c3bee27bdcf28f18a9bfd99c6ccfa0..cbb5700d12728625574ccd8fd80db0791bf7cc48 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 09dfcc95753ebb57ad7fab61cdf45b2cceb6ab19..c69cb92e1398c5bf663f6a05bd360e2adac9f781 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 496926a6d97a7a7b556bdf21046a91d582c3e916..1f3b71e9906dfae4aae21d08bae28c92e8857842 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32f88d5bfdd9db7c0d0cb93b2ea1eb8fe3ac34a9..7629711e6885ed7391d20d98d193091468073948 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 354fea81b04c370851396a78522572bcf266b3c4..ec3ddbd82737aca7d529e449aff671a01b0a542f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 185de07ccc325d5bf4b544bde91f783a631d41b1..f0c1d33428ce4f4c6f80c3efc2025fc0945b336f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e66ab3bc2fffdab985fdecaf7d510a925d4d074..0f4ce829a09ed99d74bed0afbbcfbdce86e628fe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 522de552b43ddd112ee7726de6ed9f3d0a98cb76..b0e9047951a4041470e1e8016e7c25abb723e09a 100644 (file)
@@ -1,7 +1,7 @@
 
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b78ea1dada89856ed875c7a118f6b330aa8a7c1d..616c7b85171fcc42ac70f092b2054005380d106a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9ccc839b2256d0ad82dcc2c4bd2bf45b856f1918..8e31725b7fb91ac2dad8f0c54db9085f05acf3a3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a56bf48643ad430252722f801a65b38ca57a11c2..d44335ecca97e7ae9ba2c92368e3e3f1987f6ce2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 719a81a5dab1eac04cf4ca0b21b33f193af997d5..009ce1bf1844b46c51870a0ecaf5cad0a24e0acb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 488c8397f9d6fa57ef58fc372f0620088c69e95b..b02d93493d5608ab47f06dc4c70852e3655956dd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28b7134385872631cc9041ee2a5687a9a32ac012..5f6911f5758aeaa1741094dc8aeb61c5e64a99ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 67436d18f0174d5a9b98b323d1c23ef62c082f2e..4e11fe1ff4c7f2c7454531c68369aaafc52e4136 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23be216a5a36ae7aa318701b031b96572ca769de..82da68d90ef5da4f44a34a2b4b77249ea7576afe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a765e1b8ec79d8316a46bbc9741d157a0e26356..bae7cd9d99e5997c9bef07c0125dc8dfa26d3623 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2be9d47fd4d2fbf4b21946b252284d23a3ab76a9..9b2f84366274242a2bd8a73d2d1687d15f73e21c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d3c71fdf0e341ee596fb92ccb41bfe1149eea4d..70acdca7dcfcb0813da04db88717ed5fcbec4d92 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 26a6cb8dd87b36f2239db937d161a498f00d70cc..ead2ec5073521dc8b7d0699d4b80625d95037077 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2fdb74696854fedf83509bff3f1f2a835df381f..9178e0ab57dcdf6fb1244c1d8358c93be9d20ca7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6dc03a13e24004f2d898b517228fc874579050c..fe0ff20626bdee37b9baa338aab9dc11984bb50f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc5940465503ca56059e6272fde8624c4a1ac020..bac41c296d45c8d1660bda35e913d0ac03d41e7b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5fd945e1d7e0c5801289e18ac4d1ac2fbe9cbb2b..93078d091052d8aafcd200cdfa7aefc425d864f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e26e49759d7ca6fd3817bc31248a82c6858265e7..bb35d8076bb4c854e4aa2ad1c47960c2aa3f0bbb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31ec62147874db36a3270b30bcc327c32bfd46fc..82fffc5f0e820bc0b3197c92a15da7452b679538 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbecec1e0e3696f601d1b2dd830fdde31a92662c..815158a455338f4cc8d1cfbfbf7f2ca033855f86 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff2f33d663f5f3ae7e4bb35c15a40a222ba2a878..5446465f96478097c62e6e34dde6770412bb7113 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d63ee4b936027308abe23377005844f638b67653..3218a1b696e04fc7addc9327a74512c9115e2d16 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db4ba94cf444d606d2451d7b6456b02c99858de1..a4e75eac2d18455698c786f44e8de24aaa926906 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ef71918758bf7cd7e7bcdb5926689b9a8907539..b9959c586b36aa59a78842570fa2386891feb504 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ba3ad65fc9b5babac56736041492ab1d9154d27..d61288b524c5180f5776aac9caa2771c3bc174fc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e985d3bd039c74432020f6774143baebadb654a..c65e1ce5ca3f81079971f860387faa2bf63bfec1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 30d351834bd088a789146559c36e68dec24a7a48..cd5aac4126e767416fccbe8331a0a46b7f1e0d5d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42e93dad7e4f9f5bbe69c7be90eadc473945be1b..5ce7e993bec35adcfab1ad258332d48aff46c453 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c5617b778b34ca0d1a70f034f2f45c6260253991..2022b263cf207a7e169907cebf2cd60a8b0c1e25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dda2e3f8485548b92bdf745844d51a7d5d170993..f08e25f3b9f606d65c93bdbb47cf258a6bc2eb8e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7927933932bf013caee8299b9c84032eb7869e78..6f2f19fcd706f7a326dffc00fa29bfb23671dfc6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34fb25c9816e8d2d8ec38214c557140187f9825b..6bb617eb74b36b57b37674ebd1fccf43231bfac7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d90185daaa580316155b5651f7270c995297b21..e56b54749bdd17cd0c39a7beffac3c5e76065992 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a3e8117751b36b47748b0a514415be11f844f116..f7639ed0764a959dfd1c9212cffe3b1b6318bd38 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c72cd459cd0b2be5cd7a54ba3b589082baed2bf..bad42d00f91030c2f95883aa64311f3dfc89455c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6a88b77191f514c417d3e46902b7ac4200ab3c1..2378cfa295c708c5cd4e28f9ff744f47000633bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b83fc48a0e66fca2021a434894f2f9e69d9d17ab..26774685ce270988e07b85978ba4edbb8cc55790 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 100352cb441c6c4b661fb113f332c2a539120cbd..f2f5d86ec21ad0ec8d5a4f65aa292491bf013356 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f70ca40d347fd9985547f9e2f53cc2385a55eee3..c7d501e87abf7a570b02cd111e817b2793b9a1a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2bbf4a40dd08004f3e3834093557a97464627945..803e5d21924586f2884b1f9ea91ca55c6c48c139 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5f39d9c4d29f1dc73c400bc3e9be08a38e532ecf..d48e04a66f1c3a15abeba3ae5e52b269191ceb8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84a83333292a9bea305dfe9fe0d3788a0d5d21db..97c52c7d9f74d1238ca58b77ec01dbe68f5798ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9897e7b6e2bcf22e9392eacd88b73b4efb112a05..ff0a2511dfa9997348ec78532621add2d9923e38 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6177975ed23baf7a3428e2cf12b25af6c16f988b..a76e730f0767aace3217528f8b3274ae83565e23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e55f323bb50adc71c63ea4340db074cf137cbf8c..12772c2b866f5afcede08946b89618004baeaced 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16a5652a5e164f8223a11c739c14944997586fa9..bceeeed1d977f60daa38768d346eadeaeb1bb4fc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57caee459976e85ab8b78c931a578b749eb4f263..49033b92aa836cfa92bece0f4345b45932199757 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ececb6ba232e90cdf51dda264ba64f92ba3abed5..abc508aedc7e0b998dec4de23536b6461a4f9d16 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91aeef2b37320546ff1dca380c310de21048c053..f66b07d7b9b36679f969d2131200703c2e7857ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21f8402c4bf09ca9926bc21449bd23c8898fb716..c39b5d54804ccb2aaa557b97cb364c152146d0ca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6e65be3c714b0cb69ef51c25911c4e2f2f420ed..605043de33ee968e942d1ca493c0f7b6a6e6a958 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8401b0b53e7204179a8fccb8db503331f83c5d87..9e3a4e039b1b7c18bd88f28911f3f9f3bc6af8af 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2018 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 1888632bf2191894614d375588ecd9e632f8e8ab..e490f52e56121d5969ee38d537e8aa9e202bb1fb 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2018 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 0aebfd1951f775fdf493cee05722930d66f88149..267af910271bc5e90b5bc44ef78b54de3c411b02 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2018 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 117b90efd99d6f438e53d8f12eec3a9ba35aa8e9..d40dba1c86fade388aff0aa4e1317a2580a206c0 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2016 - 2018 by the deal.II authors
+ * Copyright (C) 2016 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index efd531167fda949ccb6fb002fe0070dcba3aefe8..63165446df2b6972be4f6333af5b2047a549897d 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2018 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 967803fd000005641f9b2bf9e1da4017e117e7e4..e1a2b896b74d737b7c5c6fb20adf39362cc71e8e 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2016 - 2018 by the deal.II authors
+ * Copyright (C) 2016 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 52466f43665fe465142ba69b226cb87cdebb5be4..e08de962d31d8fc1dfdd898a08ce328697b3ed18 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2017 - 2018 by the deal.II authors
+ * Copyright (C) 2017 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 8f28ad1db04a727a09429fd24399a086ef8fa5e7..e7f7b699b9d61e61571e97cb613a02e54d917828 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2017 - 2018 by the deal.II authors
+ * Copyright (C) 2017 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index dca96485d4b76e1c2f3abfcf2694ec23853c94ac..9bcd997aca4376271f311e4a509aef63c3714679 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2018 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 63cd366303e429e925dc42d939a4d1b0b81ad5bb..202c1d8b35403ef57653ec91b145a3500aae74d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 058726441a72edb3ff310ea5a0d5a5930afed39d..a033ec3ae19c3ace7267d99b54fdd34e6f5935c6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95700ef7c8ab479ed29b24a6979e0c542e810b2c..cab24bc69d2410c7a787141e4d8cbd6d845ccb93 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II Authors
+// Copyright (C) 2015 - 2020 by the deal.II Authors
 //
 // This file is part of the deal.II library.
 //
index f6b2a82f17dbed87571490d337a3df1d7b698d68..87852df312de394f8b64bc72bc0372823f4900f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 360f7503a4f6d9a259b066842d641f6f50de555f..700d33bb10a4d848b1aa0ecdee61b3faa5a82ab4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10d273fcf07d8cbf1b0033f6883b675a15251f00..a3a48dff203ac9312565acfeb1bece0735b664c2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f903f789690d9ac8ea30b0b02df8d9e17a88a999..3184cbb2fe5b7fb48b817ec97c323333954f5fc0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 052ced19b3b59480e767d97a6e959be1fbd40831..775eecd823503809b0632a0b4534e2fedb80b7a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a119b4eaae9b6a732beacd7c83448f101b7952e7..e5461cf19809a0754577673ebbcedf0d4364e935 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1502cb66dc35eab95a4d4c3f84abfd88eb2b38d5..483b13892da2cc093ecab9dee71a77edc6b88047 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1245d252f8164ba8ab395762243cea95a0b6d96e..24b70dcdf768aa43c35344ed652ea2b9045eafed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b4ed87e2a45ede7a84ce336421664a49ef59527..e47a88ec4e9bcd7d8fa36bcaa683e00840ea7df7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 41118692aa8b0ccfde5859b163091732443b3252..1a3dcd57ec63c7f4687774a86ae45a2e93d04208 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1cadc4368c9c95dfcb24c215283b25fd5100d528..6b8c0cd4c9d755384c2bbfd5f59cc9bc32be4fc7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 452417855df172be0cfe7c33c7d2fd7a598fd3dd..9416a58e86f1cd242bd8d7bba34f27e5b0eba45f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df3bbc22ad7bc46d49293436b0f1f8ecfec8b9fe..43e5df2b4e441d6f5a298000c680cf16d24f1069 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b3f796dca992bf4262ccba7ff783ff100e22fb3..5f5a8e185a665d7e06915a0de0616b18ee6d9105 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 476030415fc290ae4a99338b82c34ff44b9be9c9..c6ca3abef99e16a058a458fd20752339a94ff81c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f908abb5d0ef39ecea81cfe35c7fb0e4fa79117d..306d3f6c5c28d69bf86b6127e2c1363d41f897dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d45f1dfbe51dc64376a17e56e9b705230be253e..c41979e02c75503e7569cfdb5f642c0368394ea2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3fb947fcc7622777cb62e9858c4f936a619c871e..457c529314fc27cfc56cb0511d8c73620e553ef5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce0740be9a4ae5f03370e4c465ce8ad2adf1af69..3c9c18fc0d25a6a3dfc1ec32ecd26d5128ecd7c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0bce450bb518699dde219ff884aaf6092647fdf..6addbe91a6b716a1b7f97a2b0ae72643f3b79bee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1960ba2b70a165a8f8dae245bbf4a4f2f13421b9..8292be58c58ce1bd851c36873579655a98d568a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e87421b4fe325de0d61a125b3ae1a8db58c4832..ef2a4af0ab77cd4282f3dacc4cb98056b5153eb7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 06d6d7a2dd7aa14dd31aaec78911e6a7f1da69aa..bf7105ee4cd40394049a5a7ea234d69f8e982dd3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 61363039e5a530de525ca519f736480642bbd25d..d635fedbb2f7df8fb74e9aa0ab11105359c7f1be 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bdc31af2c94c2aaaafef94a4c3e5dbc7dc0a55b3..a308d618daad65bb0e93a462abfb0e7e76860e54 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c36853334f2de339241ac258bb50fe351246655..5ecd3bf107c17b95557fc9e10c0e5ed0a8590087 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99af91de8d1db824ff453fd5b86c65c295d5498c..e9ab9b7734338cd871a7859b9cb572848aaecd33 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b16442543d8f8f2619d681c8b3d3515ebf533327..4801d9e6ce9e2e09c3a6e3a1e219e7dad0608d54 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 468d0f17fe14209fa691a7cd8abd2b6598ab4c02..e541d602b646d2a310740ff2f7122bbea4cd2c44 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e2a2edd763fe04e7fd8691d3d5b51e19f5c3690..c7bd832f790f7b725044b10a8defeb24d46e0fb2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11e9912dfa1d29cf08dade0893ff0b019db51d67..ff1eb448fbbd04bc31088e47dca8fcf22eeb2d4f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bededdf795d1f8f5f12c6af6501f75f7aa2200e5..103892f4de4360ad0843db6beafdd6a263cca67d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 01639983fccbca00fa4ad1feb4c83ca5ee2ed274..a26cf331b6771a362a5a7e4842977e3b51154ee1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57046138d978ec61ed1488572a4724bcd280a61c..9bbecf63e39420b50e3c8f05b1763b10ee3a3508 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 478167cc1e976538d208245246d8fa2cd5ef9d21..ddf690b1625f6914733a90e321a2ee34eb333968 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ac374e5509e39365bd15200f09960c6963a0f71..d356111b06e4455a80f6f1065e23fbab7ddd8e81 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4c4c7f54593ecdc6302a33206d9884880832eec..90cf3906be7f312ad52475fa31f8027162dfe4cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 187c8366c7c4ca671d189760612869a4d6b70cf0..6f1448ad137d24cde986d9ef3546b503a1465786 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91d3b207cc875d9bde746d74ec5a6ef1975eb7d5..da678cdd000e91b60d2740a803fdbf7a66ad0558 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 83ea1ec24e73a90b32d5a3ae8bfa317220a15cbf..2c9db7c4208d4a0464cc522208e3b90d1fd38412 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7229f64a37ea819dabfc23c1a34a4217ea0295c9..32b5dc87fa4bc257ee4d2333c0286a947ea3d223 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3829338285fd80b460c4030a7686961b41b0b194..ef7b6cef576fa9caa59e1517c96cb829394c549d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc4043b4593532200f59974445baa8538c04640d..7912444e9f0f988a01871ae9d623bdcccc46fc71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c3a0dcbb617b22fc098f153427b2fabadbc184e..16e88addb7748e29d43ed330dbbcace0354e43fb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a448a3742ad32a047024412b0caacaa5076be2cb..b56697a966bed2fbb7dfa42eed9a4cbfe3b4620e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f0853f3932fa7e5678a232347a74cc3432c4c91..bc9077c84820202afbc666d26682532e965638e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63e797967ad2ca71472827fc6afc81cfceeb16b2..4f698e873ce4868d77f2ec8d50f4fac3f664725f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0d8bccc3042210e60d7b4a720c28843d67cd9a5..abc98635f7ea3909005f6ae31a13dd4ab72372e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b54cdd28fea83ff1b33c617d715e7ee88c37a01..425aa6d59499ab42a374e3797175e90c7a5198e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4511fa0e900aab65b9f6c9d1020a0ccf62a33fc..07f0636c90b683008fa4776773165327bc0c72ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9eff9c9719db7d37b179fd05c642a4e2cbc619b6..b794779fe64eee5507747fbd5dc73fb6356cd517 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ce68de90f72b409080b48d12658406cffc9782d..84385341717e5358de2d2ba42b098a431a182142 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab1d115f96f291c1308105682b038c6be0ed0627..556afd43614b4e04bedf457be051bd09ae4dcc98 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37741e60a517c6b2e22cbaf73ce8d1d265a0271f..3f00baad2245fa957feb8df0b4fd154284900784 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bf2e1e3d73a882435090a05306564c0c7d194cf..639559b05c3719d6601c62c20a8dfdf6b1a8f121 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e178051b9752f48e6d01c1bc133683e8ae8174f..135b0c75601fb71f167e82de61e70fa53a0208d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0310911dfa76b76a4ce86b0903cc02ee0445ba7..8bbfaedea7f184865561d7c88613be426b70d8c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 627051c39e934399a28653963c835afd8f302b3d..ede84a4bd26123737279d7a6b70703ea8d3644d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f99048d902dba49d9cf3f6a101e2eeace72dcf8f..20ffa899129b9d2c0393d380d279e3a055af21ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e0ee7e49a7985b1d70e4d233e39cb5f22b87ee37..a9568bd1c5a58a20ed9e7c7f05ad02154dbdc7f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80ab9e15728bc024f3d6428b5082555f8d064343..3bae1c5adee72e046970a1623fc32119120478ba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7426c87f19d26aa7f0a8c0cbf385864e339fa1c3..151c4dfe464e7bedca9a6fbb878d4b7d945caa6c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd26ae62e18b33a332ce5c894c985252f02ab532..7a0b0d75424ec4ddcbd7c779e5127c87eca4330d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3cfebae06a29b5ed3a8dfd15c158dcaac4442522..36d29cd5a05897b8288a8ea661d5939274a49309 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 76c2987883e8e5921d162bc1d8c7134f34380eb1..f0ab12f4c83a3ce9dc1c9aeb1b2a16363984712c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0611d39764eb540eccbecd0a378c89779d272ca5..440d32a9b597f5e6a8f003a38f84187a4cec7c9f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e038671df7eb908908df602ace8f0fa876cf78df..ead6a018db2e3e99493bb4e49886e36e4edf598b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c311c865fda90f1b3d377de998bd2a598a60ae57..89e0b9ec86dc3bf0e15b74cf34a0e3cc09cae494 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4081ba8d7f880c2483c665fb15195c78b47bcbfc..05fd1a448fc2446b422c9126f2a56790d83b5be1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7bcc249c9c37d5e4c78fe14b65b3cb7693fef1d7..c60cda2f2a5e27b88886e372343d328211ba9ce0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f0fd76b6badf21aecac889989c13139ea0cfbd3..b9f1ef8270a5780b84a26efe7094e510e10af422 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3195707b233f8d821e64fb9027e612ab4827fa1f..50c66396815bb16ea2a3336bd98bb9f1fc792b44 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 401a9a27c3b2a7fc3b0b087e8b64daaf0a8cf56a..0b19eef0f76764b64b707fe0f535a733c054cd3a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39aff373d3a7169039154ffaeefd7781e1f189fa..583f5da7fa4ff3096a62009171f28dbb5979864d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4523a4be009e13463984cecbedf43512f5a84abe..db10b07a18dedfb14e6dde573cdb9a1162d33615 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 661483ee041e47305008d73b5313c19fbde661cc..2517e82c92828cdd18a81cbc4542d49d49e25d32 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc45dbd414e5fc33e6b2d0b7676420b8de194470..b641ce1bc0ccdb982eb2441fdf83840c269fb693 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 411ff6267c64d4f7c0ea11cffa37b5b7522fb88d..c78d196d17d5cbde7a05a4ebd01b2b8b03ec5efe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4c285c3a3b0f7281a2c6188f94d2027f432b93a..da9a53cbdd96810fa4c26283dbdffa05f00f22c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d01fce6c4180426998c7dab3cc58ae454696ef7..415a641ece622d370553de08f98547da2eedb567 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8bb2c9df0fc7db95211aa7f77785aaa2d549e851..4e56d72c437fc42fea8c2997541952ba06578b55 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0f10cbb94eff2a5e00a6111fcd692990b07117d..eafdb7b0c8b72cf6bac26e41ab3ca5041089fcf7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dba99a2de5dc65dafff24bf93983c16afccc946c..95cff16710fe52083584533907e28a73980ad898 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e7142e66c6ffb3f0546ced63951c8dc0dcc49abe..ff23f428100e354fb90e7e2fd4f6fd3bdeb15abf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3372ff4e79ce3b0d94717921f687efa15b2ff3a9..45fd871a319d43b8c690d3bb899ac6722e3e1090 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a523d184f29aa4d1f1142b4923e4db8da20a05b8..9811e2bc7376409ab297e1b2c3cc535f1cd626d7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a617cf6a3a97b051e94c3592f760f095fab653a6..f95285863c8a519670f0687e305cdc3056c10cb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3bfcc6da54b3c6545d85fdb45507c72b7d9c0647..b191716e73749fc6c8c6a9935b486017432fecb3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ab6c354919c5e9f8a659852b438f6c32a8cdbbd..70841102c911e0cb92de5ee23c8674c888707169 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae8a386fa2006cb1c2decb39448e2316b2ea688c..0efa95f5cf0648d9fa352aeb1fd07400b689c01d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a930ed212ac1ed9dd219ffed1e81d89ad2c2bf1..9743710904a7078df6db39b905fc7708e09b618a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad9fe72856dbdb17223928e873cdf9dbb4b2a2c4..c7db3a7bd87a5b4a22bfa504f2af3144d26b3ef4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7451e8f49b0fdcc0046361f21e2eb4f5075ca3de..fcc66087abe5ee2ffc1de093a2eb375a17a6e1f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25793f2c27af9ebb265092890fedd4cc3cf4ff54..45593b95b8ce2659f7c657670c33d1ef9ba0914a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f4d10ca012e3194155fea0d985c96a5e677f916..9ab208f84fa61a740d81f815b9f09436181c99f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cebcdf6b7a57b76254bd569f17c3552cc044097e..18cbabae0ab85f30bea312ad94b670d7a2059278 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9912641b887f0e54bfb55be4cbff2c41397000e1..50085f79fc599d9b710e13c7380412c8c8636cd1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 666c510811c84f1fa629a2115d6aa487e804e222..3f1554a4efb583dc3dc9211370df4f76f55dbf1a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 724c6c4d9a36e727235812e61b51e831a34f7d96..535cf8211dee964177050a435138ad75e46cd664 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 949f523ab80a074574fb0a490f3f1060052cbc4a..ee8d224075fd1a5c07349396941b7017016e4b12 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d19ff95b00e3419af9f492b183f44a0bed8376c3..294ee67058c259ae8b6927280a273175a7aad856 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2354d068d103076279b91b9a713405dc7aac5b72..a24dd7d3aad90c958533b387a47ff46e6acd67ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 909fc7a9e6486d7aec2020bdbe0e3ff83b632841..9d98007dbc1ebc65e21d00711121a6fdda7bce8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 456fc2be9d59eaaedbac207c717646f09b4161f8..525943b5e5795eb951cc8a92c7b3f02118a75699 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 748b4898d931ed91caa8d43a07007c108d35b4b2..8b795a2690fcfc10a031549d9eb0926624027056 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2245f10216bb72b11f9ba08581a411d8169a5714..a616e7b66b725254d96fb80600be6980b50155e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 468b9e0ea87de1a8c6c5d84a8f2beba4b28f2fe1..52d826824d117d4a7b1a1135e947e2393da36d4c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc78ee98ac8f43a3e7d8c15d9f3835e57b712147..ac7b6742e4a4bc9264feccb70deb0adc018fc746 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6824c7c43df6150f5c34e07cad595462c76c7a6a..ec517922efbaebfd1358a2feeb99825422f7cc3e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52f400ef25d51352e9d7fda5adc8340907dd92c1..884e2be1d3dd2c1c8b7c414bac8225bcb06193f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d9345d7f895c95ca7ad51153a77452a2e93b08a..0da17a9d338040d5958c1f303c777a37c1c7d8e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c644f10fad0506664d8350e8e020a72b5907b3b..f3f293d5825326c33fd87f6bf2980b83891cf493 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab34c4addda2dfa25d7a8ce763671b68cacc9be9..65dac2f7e24a0fca809230f32712d825bc915d11 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ceb9a267b9675ab3479b817caf19597688c8a068..49566b844e77384f617b13e596ce8faadef4e736 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f3442c9dcf0a4bd4eee8a6087afbef41587cd40f..41b023f5c8dda284d0abb943f6272ddcbaf484c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a1949bcb2aa2df17709c3a36864e822064495cce..bd2a8e507266cafed6d0701687d6dd0118cc9f70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71ff40266a2bee4f01af3e2d24775b14316f70ba..92f540e5334dc6b8ac922ad65b4cc38c40814064 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 309941d95481081d984ba2c4e882361e25fd5a31..ce9a39f3d94a3cbe8c00ebc0d466ac106e241cb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b363eb152cc358c4affc68319411cd90deeaaecc..8b55723e8e51de13b6c898bc7975c98d71378cc8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 028c30d6c13ba7de12013c944acd69b197f467fd..c2e609bb1f1cc947932b7fc174f17750f9e6c97a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 424b431834eaecf09bd0244f58d824cbb358cd21..953d4dadb64d16f29d2590fa7be9dbcafd210bac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c80a7b41ecb5a71c02af01944a76c8e4506aefe..6255781a0ad2d8ceca6888869a4c490d014001f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e295cab85827892e420c1e529130a0f3c13cdb78..34150657a1db58612885ec13ec91c8094d17eb49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b523977cbe67182965baa3e9c508bcfbc75aaa7..cd4396221530c15c8a25cfd7803cc9aeb8a24673 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1f049675293d0d58f8ee74a627988fb9356aa35..6ae5aa13e6f3fe5b7a932b67f2a0065970541a25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 497e316ab94668c59a4962d82389c490912513f9..0587d9c5190f04734d0f4b9f707c329f0636eb28 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d2fda39f992fd364dacd218b87765bab686cab3..11321aef7f0da98c1fc780bbec114f8e65a25643 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c57d7fd6d1b0328de9df310fecdc82ee41ccd192..fafdcbd0c22946a868ddfc878c49223e49df8b65 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e5fba6f57979aac5c1d3a9eaeb2c23144914b9cd..453e3dbf9261d67daf802cadb9b89a255f928e98 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91e664c70a776d6820900fcd0678342cc71c5dda..a44c87ab04c6d1cd8ff01d43f93635f44664daec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fbb24d76b199b578275214b7c360f8778cc5f20c..ded73054afd214f40d95be442486b44efca672cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93e6586aa24e8f8dbf42e0139598874d606116ef..012fc5a4050cba84c76b6844b182b410c9a37cb3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d17fbd7e646e7085402c8d78a0109e86aaa1b5d2..eb0135b1edf6071d8defac3882dfeea4a76ab624 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b21929875a8d55976a8b6bdea70ee964230c11b1..40777ab882a37422fbacaaaad26ae589aff0d60d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9aed79357b25453fb5c0cac54c3e37558573cc72..8469d1d77a3e1d510bbdbbc31628c024cf8ce0fe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3935f592b541e5b055e24967676aab0fc3f24827..2ca86b3f8f228b975772c0b937ccaaa421b57c29 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64f4c8b61cac7eb1ca6e532aa95d529ba548767f..fda9a74001a0fb17e4c8cb628a399c196414984f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48884671b5a599b20189779a7887773d4d801609..6bf7eca1326cd00bf0616dbb3f275e4411281168 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index abcc01e5ae94d66817ae13cc89441e1ac26580d6..c59dbaaf1f9b92d1e4188561f425b3dccf1ab270 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9eb8243a4c553c11b399b31d91cc125a757283e3..5152d7f2cf9bf46df55cd228b5592b093db7c053 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 396863e502ebb34014bec074f69f7e534d8d5e59..f5b62950680cd24521398463efe2a0da3d6efb51 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 214479d5a41a3d60a13e0a2c5217ba9c4746d766..b96fee53e81e5afdd5ee6e949e3abd97cd6b41ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9153356d12a7a5b7099c913a81a434430fbd6b80..16bec4f1b63c3b0bb245ec0420507c93caec21e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e3c973b8abbe5231e05c20c20ade68d92317cef0..4c1ce91fe81a2ecfa091716d9156ee33fda95d3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d4e2d83e0aa56e6c6ea6c8d79d5716839d542b6..d65d84d45ffdc3860c9bfdabc905abb1aae4f673 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f96cb91766750e3f314a3fa92f220d30960fb89c..14295bed5041242eff89e1e29994456c6eccea99 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45e51595bee491ee63d349be84d217e54ccfe470..59758c7ddf4f804d7e60f0b5917f513b2350d789 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da494f07ff22c52811d8ff7eef707939a88ca0a6..73a9059c0adefb75a8ed433dddfb762d6d1fcaf4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c562b80cd3cd0a35ccb1b0be96133423695cec8..a30919c8c8ce6c81215e1aaf27c38a6db5ac6434 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d932a4770fe464ff871801cedbbfb7f24a8011eb..2cadf20e2dc1d0630b5eb2273c51fc440b1273c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec581b51afcfde70d9555bb2a216c82e5064b95a..1cb8ef0e67cf90e4eab60d790cf89ac4d78125b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f57c2b9be7a20e3ea8f0e627ba0af49fed8c010..b7a56809b78bd67ece81ddc94fd6951592864eef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 003f592c17f15523d5e13a83821660a41ce5293f..5115894aba21a950f1672ecc12266f8a36fae416 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3dd4b85859c8c050fab9fa3d701b96acdc530642..6575dc41d2645ee418d2dc390f77f4290a981804 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11a58e414f97ccc47d1651366f79f379ebe96808..d33e8854be4b91207a4238ead6ab4f468e230169 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9eef484c59f7702d86a906606a9a6b9e4e3e8e7f..0d2ba58bfc3738cb2c612159840de59ebd87c9e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 431d6de65720daf582cbd9dba3bc96562936f80f..5bf724f8dee23f40937befdb7847e10e2871e3aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1564aa14510595462561031abaa06a2b92cb5d65..6ac52eb2ac41e78065a017a2f78f96dc5dc80d6c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2c71f24c8f0b150e917ab1155f696c37cf8e376..92af190893bcf8e027ce0c5095ee0bc677bbb8d2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8bdd171a4497562b3aab8df4dc497a289e8da9e7..7921f2fd927710482e758c3842ebaa0f0d0c635f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aad6b678f95c1c9ab1b5aa6a1549d1310031fce0..190a60483f392d4d9a133bbf4924537f3c0dcff2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04471aa2a611d63dd8fe4fe6319ecaa7caec164f..71dc4b74cbb4efa26a0350ce15e40cfa382cba7d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fb2fe679978abf4f2943b86db2798aac51c665d0..afee9299ddf31997db59cc1bcee45a5c32cd7f3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cae4e5df992e22b18f29f7597c1271978054b63f..ed883cc1320e74ba8b562ff985e73d763b1fc897 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d9971d3648a2cda1bdd88b8c8d59ee3ae5a679d..c065d17cc3027129c5f8a03d8afba4b434b0c73b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e7d995060775cdf6d585ebebb763320c0fa6dd91..ba9ed1d0da72ffd94f3f6e22f7fab32d7014d682 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 46730d39f0109a2f8dcf9f79f773d7289a8416d6..a361c97ea6f5f52c1a716ca2b99a66baa1730a08 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 040867187a102c73cf44688ad3d4599cbe2cd341..2e15ef0320d14e11246b810d25dbfb3415bae5c8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3d7abaaf76e1d8703c66c3bbaa7f07b476c839f..adb2e6f03b7a4e665fbe77b9270dcef849c95136 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be79c30b80257bb0feef077cb9a70f88d9345483..e7a85ce214ed89105a8ab7b6acf2e15185daddc9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5583c37b113d37112a1dd97c80268bdb5be49e7c..9ec9baef8145e8b1af819166e2cd48e441d5530b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0565706d941be56e2a3aa0acf16cc005e2db1a79..5e03d6f4df8bfd092bb11ee2ca9305d5a43e7141 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 203c0c24cfd2048d399724f031c9f758103645a3..777ae40c0efb1132c74ba9ef96145777fff5589b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a708592b8e8b54ccffaa383deb1afbe8e81b78f..19db4e328b7bfc6013acedd134c2f4bdcb01ebd2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7a0271a643b082bc20a88362298e8921d01ef465..9b1d1f893c7f0b3ea9eb59cb74d5959e6c43c712 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d10e8999c5e5897968dc206f7745ec89e57f8b1f..5f5d83eabf1df98834882694569f6104a9a15f2c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81705d7300dd7fac727f8e81a7195e53c91c66bb..ee5590b633381a7e4b8f89860b8726e9a919d259 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1fa1cc48464b57ff6a53bf78a92006edac4d9795..88769e75073f08ce26120f55b76789607732012e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 477d9efbd17d8675cd3b61f8d21b90fd2793118f..5c530f9e594f67d523e1deff28dbe38b7e3cef26 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index efbfe9aaf8863faef71309ccc406dcff188f4a36..e735d90e1857937baa0faac3aaee70be1b748429 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ffa22cdb6b0d2b121de31f29292aeba223680ddb..e2a554d4daf2a39976aa358592b6eb01b278fc7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e381160fc046c88169e1065086155c80a4692fb7..98195bf5e7d2a81a27ec9341e0b1869b5cb9dc9a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a93b6c69cfb8760dbf16c4b03d7bf1eb90c5d52d..af312f4cbc0ff475b131df1664ab809d13b2409b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bdc05df7d1431d76036d6a8ec8793c539fa6ab05..0f8db09d3076ddeef663ae879b476191c5ec4e39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f516d9423d771dfbffd17224968c14f4d968a813..5d258e17657a2e70f208e14034fb1393bf6ff498 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82baa4c9b1b177063432822a72891d37cc9e2342..ad1bb49cf2560c0de301f392923b8f3572a315a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6f4e0cf8e11444303f8cfc3984d01337b18ffd3..130734ea6d2db6e2386f87cff9e391ae13adf7c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 183ab9fc3e290225e69fb98315f2e4840fbc8c3d..4c076034232001944ccda979684f94fa85af9e32 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c7040577136ebe2020f21c2a303209fe81c126df..aef008e4cd901c329e8b3e058d3ce2b7171b08ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 504880c9901d3f55f449edcd36ac48d2344c55bc..391ff791218a5cdcd4f856932b91265d162168d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e79c5134f3ddbb301f9b8c18845f0fb1d1a923a..01f527293e73223752634700a596da06e99af26d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b00bd95b5c492c52243063a50df8ac83d3c8c616..81679f0a41f7904eeba510f28496a45fc123831c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1599f9ebef4530ab271b61f836d8a040248aa32..ee0957f67de83caa48f4f4e6373666625fe15279 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b16f1d7bd9e23aaca557fd2972896608f7aade2..040e07f499391dab0606d3e8f9cb38a6a3e90d17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d71a7ac466055f552da1501713fe706fcdecfd92..136d36076037f5a45f2ca17bb194ae4f0502c973 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 229794efd6c0465a1afc80140265cfea6db42847..f62fee806b50ccf87ce79617c257fe6b92977788 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf63dafc228e0c09cb60538484387a434d7f7521..558c8a7a058c70ea619a170643263a98c2941605 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ff25b5a8fb5315cace3455d22d5d085ed435596..a65af300cf51f9d2fee3d19c90c753af33170ce2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e5be29e0cdb7ecc44a784f4f7bd56395ca38e44a..61abf4435cf97694a200e6b21c2c6c1689e2d21b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9085e757cc5263dcd944aed3c21f7142e8d3d18b..29476471a0e2083435147666213054b6a4a40f47 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cbde6939f2e8d73cca4269d44abe73b17fb08998..100d9aff0642d4f4f496ac879b5c55982aa2c72b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6a7c4932443cafaf857fa29fddbc165cf07fdab..fe22f50c97a507c4716273b49a4bbf305983f4c9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a3ea090955e144d3a702c6fa563b36e1c5d6914a..b6fdfe19c2adaea1681bcd9a92a3e0c0ca55a7fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d385c0dca4063bc9b524469338add0527d9aa77..678af6ef70fa37816c30082ed44b5b251dd1fb53 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6fe15a6442c10b40821160b8b55f81cc31080d64..223ac097f5b77835d5684910bc7e4967a5f67929 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f129110eb47c425d5a43011b7176d2a86700a82..270d54106438e5c393a82c1313d6927ae3615d54 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1cbe40f7bf403b5d09fb15bed298a19920d39cce..728aecb33859cc07b4a15978ebe9a3e532ace4c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d07d5996726853d0f0086026acae4353cd383d6f..17c23aff5bdddff7f32831897d4dc71fbca0d076 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a06ab383b20ddbe801a80d2acb724f0a15b545c..8f69239796bc1370c2789316695159f2137c13f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d29a7aae4c8146fdbd310c6258aa67856dbc2e3..56c9c97f01ef2ef1dfd47534d462c8c2ea4230de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 564c37bdb6c25752fabf13c542d86047b5711017..64fc8a955629592da59019cb06d120d0a784cadf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a36fc041ae89cf9a91d90eafd300e79766aa4c51..d0566653cfa7f662f6a5bc5f8798052e4c5b682e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b4c0b82f1db27c41ad71e1fe4ac4c92301e0605..f8d50be2273c02cfd153756bd4d81a7046a11a7e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d2d6150ad39bbdce968f0157fd51312078016c3a..c266947c5f585829d366c763489e81fd57a59c88 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17786f705c1943fc0d729e9be2969ca436e2e9e0..80eb3dc4594ae7db5be236bce43b064a976eaade 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8dad5d4e21537e5877a4d0acee064a8c8fffdfb..5ea1a127d91d61b1707d92a2ef5c531db1ed10f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ed7a3e5b62b1dba9e6d7f0069d261eaa0c66c5a..a5879114176c75c91734bf089b6fdb881820b7cd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28b02b0db54979e3ac32ea0231a5336ceb69d418..f7ae45eb9e55d609d3489c40f62affe57b563cdf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 41269b697df21d882f6c105f572a4920cd70d066..3f88871fd9153ea712c9bcef425b2157b1921d66 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f0a10d551b5416889493b4d7e37021bc9355691..6090e74778f4f4aca959c53dd85db469facf079b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fb66be308f747aec2061756040b99e77e4b7a383..ca37a77ff2f2385448566e4f3cf208bfc43b2db7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ceacace6bb41eb237284be027666a0a91f596697..9fbd388257ce0ca329654e521592e40e5dcc4fd4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 015cabdd4267df8ededa325808b49a117a15c6dc..9a58554f0cddf8cf8acf0741f19d2ccb8cdcd7c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eaa8c041f8164f4be0e2e64493031c047a32da50..b4381f17123d02e8c062929aa9c89cf3cf56b515 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a01437d28aa12b1ec838f19abaaa913be8b9b6b9..b6712f854686ba666662df1e4eadbfe54f0f0890 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57157cf2f6f995d258058c3f925ef4beefc72689..811b75dccbabf8b846e01989623e0f3d1aa779ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fab6c201701f152076014b603946206288afdf43..bd6606e9dbca3e86a0c6f2291f0667510b8b9e08 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a866328bb20a0791262495a53f531e5222235d0..d1fb27939b426692e78018de65e70bb392a3d863 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4eec9fbf2339cd3e30ae441c42446d19f7f6f77a..de2f407eca840428d6252b8622c6c24002dc9829 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4acfd6a64df13ca9e109899c473782a474ab6ceb..c0a25a50a0dd5957ff1017d53764cb3038edc02b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e89274b5afdfc129cb93921152b5be41cdaf4eac..a8948a7af2f7841c194eee5234c168a62882e520 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38bea51b31f996822ac1d254c59fbc7542b6ff6b..fd4bd9017d5d7d2718e490910d1707c038b012ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 41ddc47a7af5042e3eddd6e666bebd40b7210c28..8af84906649b39e528c9cb4d5d7cae0cea1a6fba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 961913b82830dc8b64c8883454c205e87a85c102..cca0cf7399639ce7682cc8c0b13a3c02472287a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d0864200c32c442e777e7e948da5fa285f43dc0..d2a7a422cd638575f57470bf6dfc8b11445f6a06 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 36a952a54785d76db311c5500cc9b6b71a013783..9bb62f6af16cd8c8ef331b551f72de6137fe7ab5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3894e4fd5f03a32078d33f95d4b38c024d3dfae9..a639200b96167e265cf43b1f25068ba1e50d6452 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 031071c1c2e5bb41936826dfa32bf3c55a8e5786..b348ce8dbf1ce2b5b987c71584d4b6c4aac18047 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 513aa7d179677622b2bb66ce364c19f00b30077d..c31bb631e58a929122ea87cfdaadcc0c8dc9f0b0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a1c7adacb1c1a067d6d7b543e73029ce4a6a985a..45de924f933f1ad3fe1274365cfb0216945e8496 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7aa320b8125a796c41330ca666f21a1f6b1e16a9..738254a7875ea688b27d827e7a1ba58a1a93bf7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2019 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ea165b59e1f42c04d505bde2421b59a44f3ba1c..403e8f17ffb5faea5a7cd737c10020143b850e07 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b1a936eeb7aedd4daf97a54114d27f5a3c9f57e8..4f3abf512896c1ba6a918f58e62d9c46a9cf5380 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ddc97484fb19cc2841ee0734fefc26c154d8604..5b866b1b18955972a1987f126786ce43d5df8b16 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 912cb660103515683bced955d6636804f6f12557..7ac14e48b17bdf279fbf359eacabf094c2d8ab8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 202fb511593f866cfc2a1af8c3b1200ae55014fd..84e66c166a5c3460ed657efbe04f008495046eca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b6146f50e0c136273a03c8eb1a406bbd66b9099..9a5666fe14c4577cc0b89710a3c215ae06f965ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 83161e11d1f2e03aa09e904e29710bb787c7ee83..85959698f50b1b44ebea28b68bea144caa8edade 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c48be3601eb985a25339ef57a03d63b8b5e1a082..9967c6a5212887d4a808ea73e56a0579bc389e8c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 47515934019b76e6790909195f34ee6e05b5cdcb..5bb56bff9175aa9b7063e6272c3253c64860dc70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0790f420854581c6cb771c59b9e6c5bf2d864bbd..b5b24de8f6ab8634098ffeeeb7c5ce2d9f3113d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 285fab86e888f16052c50c1641e9a7621833fbde..80620f22403b753a8d0f6b6781432659758b53e7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 00aca6d052e07517b5ebc59270349c3c61e1f919..e7945c0a558ce2dfda3e35dd30d8909594d48e6c 100644 (file)
@@ -1,5 +1,5 @@
 // ---------------------------------------------------------------------
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f90b1b8afa4d233c4f95e1d7c23eca76062feb08..ad6efc1127d85601d9654fe9808acbbebab8f2eb 100644 (file)
@@ -1,5 +1,5 @@
 // ---------------------------------------------------------------------
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9383a52ca1274ed6d047291e4d599ff72c931624..a224c48a62b7a4c405e99bb1808accd9263fcfd3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2c11478ddb7cde6c5374b82e7bb39f4bb238ccc..c172d5af7678a1fb7563d06b43e43f7a09f54597 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b049046f15763a9a0687bfd192917e1c9ed5fbe9..1270e6ea76e270dd0fdc2f2203921c631ab1d65b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68a2ef8974d689a15b86bc0f76a3779b2215a2b5..8a72897c149cc66a93f55ec25bea42719e052ca0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50813d65c6464cc66eab18b0d6dc77d467cc0d22..2476c522b2d2cfd46d377efa014d7a4e22567e48 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2c2b80e2e62d84bdafb448587d84c36c2e51bb3..6631bc3248c11fb6197b6c23ff4076041043cfe2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1415743cfc235ecfc54c4cef9e19ec6fe03e6f1a..1b94e3f3a76bb6310b6cda58d5841fe829744fca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e100b76563f4f984db9614df22713a4e9b50e808..60bea82566c366b5bf301734d54e45d191a69dcf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5de892fd718866c2cd3f01d116bc898c4a1c796e..1afedb5607753c8cbe06c32f4bf6c8936363575f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec5b9b6e81855dea7bd4c447ea637aa9a366ff21..dbb59502732e14be568530902d70707ce07ad9c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b4c6434dcd4b01c6ad541817e1afcf3c1bc8abb..c789a2c5c55c1f1b6ef0766576c8a5eb1a0dbdb2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e1467460df366c0d6f4508356dceadcc7c6db40..f1c73722502f863f3803cfc110d2378a271753ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 426958bba6dacc73c50da3be8756b7a097c081c5..1453c3ba970557cc60a888ac00a06e1b3e60747d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8afa0795e234f509b80e595400ea1e7580f6bccb..45f531ed62419c097bd1829297fc3029bf30fde1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dcae3c9c189384fa384be0d5ec131b7c583612c8..333e2e01d2a763abad068001bb22c73328bd9005 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d273a25a6b77e60e2141307c354abcbfc747896..6953211136dfa590a8c9371db95c54b598c17229 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12da3197e326d40b2b844d7e633e130e116d2eea..eec6a3ef533e575aecd946d57c5a416eec678368 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0f72e6e9ace016e603190a4a446eb3124fe6f9a9..d0a8dba66b3cfcb245ead13f39bc64a65b5e8424 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b5a0a8fbb77f92ca2817d42ff3cebe77e6c719d..22866c44988241fcf3ce8ffd3965bc981c8e0d99 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2299573b459baa6222a6d06ce3975fb3ba0d2cd3..aaac8978b3f91d79e1f398a51a58a57948771584 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59a8f5aa7a936fed15e497c5765504f356174778..e9968b9180cadcd550dce2d0c7270763d614fb2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0af98f7e3e4bd8acbd36cffba1999e7015e70411..6218ebb5d7c609580dc6e20e96b90957fb023d17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1677e5040b0538c50c4a2bd60d5918152f3ecf3e..ff7e7fa1f58d6ff72da759e947540f2591dacb03 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5028dbfcf918062a807d5ae0f8f32861b560381e..c2ab6fd00bcae3930f9987be79021ba48de4f70c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f99245281f1f54a7a33202d9300bdea8708d383e..6961b2335424307714f4a821e9fb1421dcd02dd2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 464b720b4b947da3a1301b8234c170b4a9d7e8e5..4cbddd6b80338cfbd8657cfe28d4bdf1b2e72274 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc9e26fb0e19df3c75626b029b2cf38e9b9f5026..077526caf5adac892af401b82175729a4d31a8f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a9a373a5c41c1ee141e0d3d14bddefcad2fbba9d..df7678648ed4654775b2937ecb5e016b27fde8eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91cb76c47552d2228ee86bf99734513e4f197cbe..9f20c3a6fe34ea63235e971ddcbd46bd202117ca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fee9f02c15f8347ab29a6670dcbb899415e1f3d7..734528e19afa49bf3cfeee5f935afa79293cd6df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0f2bb8ea01d9c378b675fa6f0ac02ecd8be6f5a9..772e070c3b9c62ddda5d96c8ddc7e07821199cb9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7635babd08a3a86c2937858284a7bdeefb49d68f..f07c759b6568f75dffb42a68dbd8eff40b9c650c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9436f46916aa89e52a62b5f87ca5c84403f9d37..dfdebc7c567149eb6e2f736729337dd0e32ebbba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bcc116e97e0bdcf34f673d789af8de627153d477..4fa4a96c5306e7029ef08b30349e8addbf60c1fd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db4459737f93a18b2ffda3ab96e052bbf0765b1b..b76bb439e1b1e5bd3c736c66fd718f132edf533a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0f275105100f7d02089a0bcd8661f59d163c9b0..8dc1857f743e43f93224988bb9b42c3cb0b0a0b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0da8effe66e90f7781eb60c75eea2a5af3c59902..535844057abaef51cb33bc6a3bef1d8876edd878 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 330c2bcd4dc1e05b0d18bf2ae376ab35c8d6c407..2d16e9ecdade8cba2bf72cdce88026c312c344a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8f4c45b6e2118bd20c61e4e042342426c9e8c2e..c68535fb2b2b4107b5c3dccef12a697cdd156128 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ccfe513d241bac4b5831e21ee5f71b38460580b9..ae875ff316fdcaea221f0cb1aac6df70f77d4146 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ed1bac65e1193738f2e55c5692567125b5dbbe9..dd50a0d828af58473bbae998d370c5b56bca7dd5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1fd1c24f922d7c995ea1ef93fddafdb451218f8d..7ea1bcbbd7dec1ea9d8257fd652a79f56e8736b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ccb1f24feb2b6f487167e8ec9b08b03ba37dc12..722d7f5a7951bfbedd0ee6d347672885d21c1005 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b35ba70f52206166ad3c581f9072090b54860457..7d339c92bb2bee6433368d94ab0843cc50c75358 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d820cba8572503ee3c7ee86e243962ea152fe98..54dc44e6fecf6712e5dc398b9e080c35b7a35e63 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9f497613deaf747b2783ebf856575f9db5a12ad..8c3d547f77a0f92942fa3a2f0e67fd3d1bc32b5e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6691f78203b177ed02621862cfd84b5113ab37d..5582409a15de96e50af60403d0ddfde347f037c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1084c7ad35ce287e4319eee1fa6de49194280133..f6110629eb98654a36c97fbc157a73526ee11575 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6172961f366fc244728f410eb2d555b9b8837b8c..72a826f155f223e098d3ae1b6557c776b8296701 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9ec568d20b9304b67128594d1ebb292a8d59c91d..3fa6ff0d756cb78f3f344e5152a2778d95651408 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8fb08195d8d3f8f4b79bc6f507d77099f257baa0..b5e8c041d815ac971d042663ac87e3936c074605 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba0e39d34e11a8cb74b04781d9208dd8a775f227..be94c8211e865a6f581cd85166d4a663a3a4d0a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f40bf99020684352aef9101a901605679dc799cf..4e956bc35bc586a841314f6d20fc3b90fe1608a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd3dbae429b5c987a86e0be0c38429fa4e6439f9..a6bc73e86ac5ea19b445ab1182d43eab9abcb818 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff7a9a946d69a443d98892c7ca593239b65095c5..718be22a29da30626d9dc731ad7544a166befc5f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14dfcaca503eb8afa775e6b8fdc9abc7628b9f3e..fb035c4c12ba2f926913799d38bafd4c6eee13da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ac859ff50f337bd9e6bef9b7892db71347ff2023..a386af306de5cafdec53d1bbc51741e68878a34e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fcd0205d00114a8dde42708e0541f7f82df79a82..83d72bd373f2c9c9588de232a1da1d9ca733c2da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0c555e3fda2f1f24ad430d3c3c015354bda029bf..2fea33737f588fa1b39447adc22ecd374a727e17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6c7c9015e15996ea4fec19efe63a776bf914b2b..384b45f6a6bcc6765186a592c50b0a25ee96a557 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f62fbe839b8f46db61e3bbf7a84b36a2806cfa28..5e7220fe455f7d431ac0d57e4c30b5fa5984edec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3242b72e82207770f481aa126e62f78f1be0f68..9d70727da7a9664e088813e7a434f5bfaa175e5d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1fe34c313bf0a6702802cbdfead2363599fe224b..e3755dcd4f6f231af45a5db823d6bd118bc84399 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a46cb6c0980b3b30cad1bf7e7a0efe45831def8..e46cafbf71ce4f564fde4cfb1e839f9f6fd2352b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d3ac29dc3d5eb30500b87b1f4cd9b3ac4e4ae13..e69ffd77802e1a370fbe3196fefe3586ff9dfc4b 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2000 - 2018 by the deal.II authors
+ * Copyright (C) 2000 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 69592f33e182fda10b4bd9ec5d2f6599db0699b7..b7478e78827bee85287dc47fc2f9ac9cf343dedf 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2000 - 2018 by the deal.II authors
+ * Copyright (C) 2000 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index c3420addab9c3a2f7c57a99020741c27205608ec..97f3773a3b70d820f2f5a523b3efd350c6f5c069 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1dff698889fe76dca9ae260a417d3b8443172d00..2156fc5a0f94326377404990b890e7e48b346470 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b29ad068059b5500d52a0edb09ed46b81af5da5f..d812eef1ed297c75fabef4ecf83a2ba7fe58ffe7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1eb923c07307c12f5c5abcaa1fcad95e81682f63..132d3e4b7176b12d3740b8701c2cdfd631ea1858 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05465f01dfbd97d9ea97c73dd4e989115cd66144..9d31fe0bca731886b1621f7f56089e2319ee4253 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a249fc06db4ea369847f78709eafaa3456fdcc52..3a838468a1818e3ccc2ae2ed54410d6d31ba7cb0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12d607826bae03039deb0efbf9a8fb70e09e7d80..40db9702c792b395b0e47602a9a1014632bc3afb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4d3f7593f2547eb54c85fa16fd53ad2da5af39a..188a1317e963d135a73877d3993039831337b98a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1ebed879018d6251e66827779a4e0b737ebd7c5..370b5b49c5534bc6bc45dc92f1cfdba1f64305ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52285f75b84c419a5baf6435c86f794f6bb3123f..159a33d08adea6d56baa33ea4458d65bc12a8a67 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a8b9d91dec4e1e5fa6442fcc9fb5423ebb9a9da8..3766966de97d543a5a0548c6188f05bda77e6e74 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8d9fa8fb0dcc565593e98b94ed86ef03b54c294..6ade1fc5fb48d3c923a7a2808994a73d0f8723bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3122ee3c6c28ce75dc6db23f4e6dbdc0d5a1eab9..680acca964af8c8224fdc7610ed342b034595b7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75036a16a6e6abc41a7b2bb95a99efa428e20b4a..7628112b9bd540ffb2da23e869916b3708c5acca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6d70ebfb85bd905bd0c202eb95e016bf34dd12a..accceeda201c64cd67e3e885c99e2388d8872b71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab575a6e460287c6fa9d946eb830d905dad75c9e..c71edf52e048474efc9cae13291303cabf8c3a5e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55e4f83a7841c4e0ba52a359eb23b44035724f8b..0e49d42b0d393038008f541454289c49aecc2aa2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fbeb03c1fb15d9d051f22ea3d3c592a2d03686cc..837a1ad052f7c4e29c8fa910e03f0bf60315bdd6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3e3014c332ff162472e22787f7c42ef4fc8c213..7aae26f6f2c327fa11453aebde6a81ad6bb2e38c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e084c6a61fd3cb00030a52e8cd49fd9d01edc5ea..7add9a18c7e3d8b89a3c753cf3750647b938aadd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0b1912c1b0569de606456ae5e67c11634459f03..f641348b239f975257b0d9cb1d34fe0a407765ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc2a47b4b5fc48e4111aec131e4d7f6138811ec0..562dd9f5a2179e6b1049a2f900ad5e9eb6e929c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54bb757f33eb93707765b716d97a6cca5777c043..0920d3122851ed2660443657110bfaaa94636e39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9466c287c66ee69b57489defca78ad49153b1c55..75d133dd1e3a309ff27fb805d289469f25e16f7a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 900a7947a42587414298c5b36901879b5b97415a..44cce4b469672a704c6d5e431b8ada2f1546e376 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f32b8c510c3816ffc02daaf3c6c47f87c6ad3f38..b5c136a9d357dbe3ac102f0aa9de6ad8bbe80c0b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index abaa77ec5fbefb5da75b7bafe2912e014b11b407..7cda1a0f48ee1519f81070628d64c04e067ab811 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 096ca48e294fb0a91dbf078cfb24dbf826eb3118..b2ea88a80cd7521d2aed4ce22e46d36333043c19 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03a2da167b5d55b5f7530b361586d7bd7367da0f..b19dd1d2e016fbfc1c2269b52dadcdf46ccb3542 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b4fbebbe83fe1445d216b18fb64a4855249afbb..fef9b39bac017c8f5f1e776d9999e04688c67f7b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 256c20c4a0f44c03ed09ed189a3fa9ca995e4c9f..107fe98a3b5fa328f1a89c2ef6347b47c89825a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 818c529453b444c999b93242cf4a19ba473713cb..dbe6f4e09e439c5a2350c1fd60187823297e57d2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4747167fcac5a1241f01e538fd612e8ddc805ae..d179dc612782a09adef84b891385f9c1c2218c46 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 30f06e1f3cfcd3d4ef3f53be905e698efaeaae91..bfbbb522a301677fcf42bab761e8c13f77be4fc2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59e2f88e694f072031df43e0308ac8bcb9816a08..41af39e22fcc13e3056d3a1efcdd95466395d059 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 200a02b919b7f74538d8bea4aa3369d9aaf7503e..362d339b77c490034b4d65f4f4a8d2c64f5e2eee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5cac54bcb02fdfc95e4767cc14ca978180f47de1..d469e6aea28ccbe851474e53e6b0945143d610f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 924fcd1983b1b86be9efecf5c93ba5d013829e9b..4242e15fc8471a7f34b9450ef6d544a0d8b96a51 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3548ecafea97913debdbf38e312802ecda537b5a..d83a97c7aa2316021befe2bf7ceb9d92ea4b3d6a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85f250fa276e21804becebb6e1ad23d9954378d0..9a53be8a4f18fe665e9ee4ac6b97b502bd44fda0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7a07d55aaa53f4a537cc91c3a5e6312f6c9cd1c..863c0c0375c8354f115499b0bd0dfcebba190c88 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d51872011e000c5f9e136aac97603e2b194b76f4..22203907e3d6285e3a71f5dd1ef53a6d68046d7b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81b97b494b0d05c1cb4542d7fab491b0ba1d5ad6..73836a6182c7cf1c887351b74ffc99ff58cb2207 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 02804eafa4fc18838b173e26eccca6ed33244849..d88459b757fde3597de256acd0883a12116d31e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f8fbde0d4dbaddb617fee306705aa3f753fd3b63..204b60751f0480f9f3228a3b2895c325a60311c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6024795c0da3a817f43e141a6802f403de5b0c91..94e997b58f5e90010e92c0a1eb416ed39d372c72 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 843c92df900332e6d846c217141b6fa1c55cc618..79c2435efa591adad5e2c69ccd3d4ba0369f59c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd05971f64109d3cdbc96184de41891e19b95bfc..5112e62aa0c4607612e27c1b7470650edbc14cca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86e229787c8630ba1427183aa6434cb903c3de6c..846f250222e17d1c6fa56424dcd5e88dedf0ee18 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f78182aa7b8049b6dd718ae924ee6dea5c532867..25fa72655156ef7a29432e1805efd7f2dd5aa99c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c40cd8c01f42fde58c3d2187ecee9b59115c223..60b546a9d6f930a34631897978cee9a080c4d54d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b35a66f07424ef7c2e260399e4ce3376e067658a..c72a3c1ddb941b74132246b8dd7931c26e2e7d8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 00c8c5d301cacabd12b8e0d5ee90bbbe687d9aa8..8a2b6e44c2362c387171955d098c5861471f2310 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d82b236b58327d251bebe4fc29e283e1ca0ebf3..13755381652056c7b7af3673c53d0e2607b2610a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60357fe91130a7d8281c693d276d0f8a511911a2..0fb5848b423ea93d4dc38a39dd2165cdc004f1d2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4fc125149b42826214028187ab8fe1eb84a792af..5a1d0038d6190a7b6b9b59802999a203a4776b65 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 280ccd8a68da47c4fee0e687248f7a21e3b64189..db2c9efcb454e2a03a5f708d83806e978ff78956 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8e2089dbb2688e2a8de67b730046bc2fa2bb99f..0d6d7e3448f932ef38cf6998ab8335b7604765ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d102b9390dac1bd09a6acc2d6609ebf8c0f24ae5..e92488351f6475fdd6a62dac0e55eb98fcf08513 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2019 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be56439459677fe4f1b86cfeebf19769eaae6420..94d5e51325cee9aa3126778d88d5988a46e9c114 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a46e62f4651bca71318884515b8e79bd07c1fb0e..a6d456a7b548fa1f7abd168be5138a0a4c7501a6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af2e7589db172faace0f81f7954df20541e21252..d84c7543554ccc6ee27f608a84ebb81ec6dba1a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb99737683825f9f4003e40e94e1bab77c2d1469..628fe527ff40b58a36eac11d5a295b89c305c94d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f41c8ceabd0544957a70130ecb87c8c3aa981a68..7056a4ff5566a2759a567499451e0615b51bf044 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f057e2feae2cd45a2b95b7bfb9ae65c674bcff0..c51643fb9affb90869c5145674f2d0143bb52728 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3530a2b24c8ea2b1e54a5ab5419385af02aaf25b..757d9d475b2ac61bb1c3e850f67be1c49c08fd2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13b0be4320b2a24f885fd01980630396d1d26136..8bffac09368c6f111da5feb47c650674c5474934 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40d3f102489b96bb30860d045a03e4ddc29a300f..651718587d28311e5c9743d4eab6968cebdf9cc6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e77c22918c0d5a5a88a322a985c633b8f2eaba2..64ede090c2474057e13c978feefb12c082d18f46 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 62b6e483d2eccfdf73815f7330631ac6cd516be5..652b3fe7a7cd6c542dac6426e2f5469982898708 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e6d4c5007c1ecd834b23c910c45577b63dafb6c..90d46a654d4f3622f564297874fb89714718eccc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 790f0c38d89c4593b7a0dac675b8e68416e2a40d..28778c5d33df1ea87159e24bbfd1ac8ecd8fa770 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9437e721fd5912856d8c82b4022551d4c66c8b39..f823543eaa7a7823b566739b4c59ba08a834e737 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a68cb87c1d697df98dbc8a1e51aa79e563b9e676..5965d6a6a46487f275901a65ee60fef134a51e8c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da5f2f5a3b6d8372cdef52cb529dc301b849da56..2ea07c3fb38468c737462702ed8ac20b034c867e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 180f651e85b23389c4eb86c631873799add73091..90e14c9f33edd86991f84b857144fdaf1280b925 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2e1825cb1051e1ec11fc1c73dac96a439526fdc..b4b21a0c831ec382aeebb336b442539d34a6c4c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4cbce693cc569432138d96a1accf85b82946372..afcd75f46b54451021cae8045be0dd4b5e6173d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4effaed5aaf1bdad767ed63b5969dec4b40fa572..25732be20ca1c3dc1111ff639d8df465d9965e4f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11b0b76701d33714e60cc74bd1076cb7b3de3fdb..a575fc10011c1d5f6299c4fa3f1641208632f1d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d292869438f4852de4e8dc9d09e498b25edab5a0..f77fa441575d47aaaf844f69aa8095f5d68ac4b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 981161a89a8fbbfb44c804b8dce4b473725fcc31..b5f3a1c0ca8e0043ca4b9dd0657cea7b4b71eb66 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b81b2bb9578abc456bc875ba62201935ece4ef6..a2001cb8ca34ed3b6f53086370ab9cd592e7b9e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f6b1cb5336a36efceb5203ef8e754c654aa06a1..fed74487e99459973975fbbf34657fd9e3acd7ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75190cd431a6fd0a1ab00b414141d58acaf873bb..be6b12e6386c9ed8ad72a4f7ff98eb999d1f2075 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f071eddbcc3c66b0cb5750b6096bcde90a7046a8..e059e9257a84b3bdf33200a6be63e03926177db2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db6dd863503d7c10650b01decfb2cf68248f726a..fe7e44aaca9b6c1e80398286436bbffe2f6147a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad52a55258e67229ea93656f56645cbb99dcf233..ab52ddbd295f75b97e585118e015bb139cceb849 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b2d89dc6575fe0f0087508e1503d8a85e543a873..253d3e8e9c10caaf46059222a59de47f8f9e2af9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4e4984b4d708a2f6df0b3d2e6b927be5618240a..168bcefcbdd1e78c7d8ebd8d8d6e8de73012a8a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f653580427098411961b299d860468ea13fa65d..81f694e562888142b57d3fb833e3e030cd2beff5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e3875f43078e92535155bb154d719c9aa9197575..a22391f754e66b1daecdc884029743a6dc170c47 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fb7952d474ef345ad3581743d925e6e233f8a189..49fd98f19562b93f585ec275af76e36f68485d55 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 066f8afac810433571da2994996f7c582c1214a1..7bed440471cefe6bee99809681cc85aa8e74f4a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 58820d6df7274b5500d838c8c0334e842dc0e8ff..4f08e28f4aad825b03898a834ea79626b1e6d5f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3159b0f410bbe12a8786dc56eb6625442e8058cb..246488ee0b302544260561eb77b15a734f611f37 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4976112ae7e6e200238b0f0e4f35648cb1b20120..64c13a05576b191147aaad98b27f45ae60f6a21c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 272aefbc03526b7fff6264a4f2bef6e87bc15301..3e1f833980bca04a0664ea691c77cf58f2a631cf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2430cd8855deba563003d4ba2a197bf53dda40c5..a721d8367ae8e80d4cae499e1bd1a91f77947500 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1648a0a587ac86fdb3f65d5d1c210c1e06778f56..9d7a20c3b335b74d94ef9b0380cf6d261e36f5f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ff5e1adce162a7107e2caee0ec023663eb3de29..c804c599c4d65a72e2ef93ad02ed748ff0ca019b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1a849714276142a405d9af04463b22ca7541cf3..6dd41c1fb328b94b283c87218a26b8e4fc165a80 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d74f64a2c7e41838f404bbff2d3deacc796ce985..c5b061227ecab1ee8e29f755a4ff533cc2d1c8b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba65a01b8d565db5aa96cc702b4eb6b3c32646e6..81adf2672fb6012e45d0c8e57b70933456b9895a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e93b7e211bda07190a00c3be4d0cc4853ff52b90..92b37659ad02a0462b46dd0b3a3d4941e806192d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad0613afe853d396b036451d05d9cc084a1c2a75..7bb6981679fe44b51571f746c52c8c27694ab355 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 632ec576be00f67e86658a121c90f6d40c864a8e..9a8ca4626f769ce2ba672ad2b3f425744b33aa74 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6419bc85e8bf72d36e83f3918f568d33309dc65..04e43a0ec5f614568e0bf47c5e0a5acd7c6c04a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf4049940b56cd23b25fa206cfd32f7d94752c97..507cc2ab510b45f433fc6ee67a356982eb4884af 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c05bc747d85f5e3793419ac149fef6f90a1634e8..e7ea671ff51ff57d7f3e59b2a20908b1de9e0ddc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0bd94caf801f1e92151e2431ec8eae8e5642b08..97f6b857fedbd004dd1131e405b16c33f796fbfc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index acfea62115f8df3617839429a1639f6918b339b7..364830c6620c47ba932b9fc4eb8956e5483146c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96e60b0971043e1058df702724d6a19a888decc8..965475da6abe5c1183e24aff80cc23bcb9f32531 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b91b7f75dea8a6bf70c9f1060d8de6cf05e31ff1..c813514c9591e2505a36b99e4afc9e326f820cb6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfd76f30f533b3a2adf958a3570387d14cd7a559..61ab9020c8f50111accd29210578993ea63cfdb2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf7182d79d8517ba780ffd5177c9de8a1f7f7d28..ea1166ef98dcc055e236b36abac58e0438e2e79a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4a3144bbdead7e6b723ba90d6080b72dd7844de..c73cc017cc89192f665b43fdd4a82000066a8827 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 098eb532252865d411297687748c3f8c5a2c1158..8a92fac992387bf3a21b2de2a1149e71a5a82c17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5fd31b1e80fc5cb60259d6a025e3127b877e80a3..217ab358f10788aa05fe86c676bf9dabf30f84cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e8c5698ab0b27c3409470a2c72e00f137a9bdfa..69cb51b3e0bc1693c1d2f779497488a298caa52c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4e115f35c077fd453a49713ea4482c3ead0b289..53c77575d385776d9f4632e97381cab5ba65ddf2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0cd1d35aec8bc1ec1e71a14d3a5c0aafb48043d..2dd06d3dc017b34cea8f2b96c174adb6445c9b0b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a564a3f5623aaf9cf1844f41b3211575327dfa0..c4c465e3987e4e9dea485d1171bd7e5b473df5d5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 275556c26c134c3054af235a61306f49e3d10c6e..3844450f9084f2102473acb36cd1d1ed7335b85f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 402965580f9b0e828b94cae2bf4b60358bf8d3bc..6a33db4d9cde8ee0abb312940a71bff72bd895b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12e8b6b5c584f98f351fe280803c6423861c5557..f3665462921deb71efed7ae2e7adc59ea9779a9c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a66b8c4cff86705d8f068256455583f020af599..571359b8f4c4a4d242b9bcd88edec3dc118f4bb6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 863ba4e1ccd5c201c8350bc5b6f54070f1898af9..216e57282f520da62b1451a81230dac26344bf43 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0cb31e5a6b03761966fa49b704058bc441d6a578..de91f1ec1f58adccc960c673f9e0a13e642e2af8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f78b19c0995ad4ed0a5eee8b55af9fd85b80057..3a1747374482cd37cd410c7d4b542a13dc020997 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0974931c8501d1ed3757934a033e5e801018475a..2e7dead093ac5594022e28797d6aa2bc9833b930 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ad9a233f132c242dd53eae4ed10e60e04552a4d..4c05dd6ab2a6a2ef2d7079271baf0c04368ddb27 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5881864605914ff1b4255a003802342d5458cfe..dd035cc79cbb8468f91bcbd63910975cb496fa3e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 826574a4e9d9e463d780b02675df26b240d3ffbf..477c6e0db0080f0cf1e2149d06e297c644cfb98c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d91b443076cc157d907acd412ef311c92a67a98..c6f3d52cf90215511c0f9be6c5ac14e1d0d87954 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 476f8070cfdfbd334eaff8675e6eade1d432c602..25c79a1671605472f977dd69ddd3a6e5c3526f75 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b329a5967943b4225de77af1ae71beb3c1c43ee6..a2a54bf2c07de6854b0b180e56b85c219800e5e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c12ea1b1e3f6e1c7092b06e4443d876681de15f..3aeab2aa1086669dc00911b27e34d726da29362f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99f1e55ad6da6f39295a599347be8dc411884730..902ad180c66f6fe0e3e69ba9aaa9fbb1981a8822 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ad86b93da8ca329bb3e3b3553b8c9cbfdfe4ba6..946a7028683d7dd5e60b0b6def4008e5e1c5d03b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0c45aca1c8af82591c33cce0d7da888ee5ceeb9a..3836a076ca7f5b34e2ae9f5f4f46f93bd15baebb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0daf8bb62bcf4e5c78ecf1d7cd3ea5f2c72e5940..be5d1cec276f1df82a53e210262905e7a112e559 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index faa4b327a066e848f066bdda62f82d10e61091b7..539662b627d79ad37d1c80063536672f232d7695 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bf7a7b1efe729281fd2562e1801a311b437d07b..2ea0582777377456cb57303d6d232bf46bd90711 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f67b758c20505b9bd5231b52fc9810ea289ee86..4dfaa0043e641c34fccde97ac52894fa63b93d89 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II Authors
+// Copyright (C) 2015 - 2020 by the deal.II Authors
 //
 // This file is part of the deal.II library.
 //
index 76c36204e78a106722db0ea8e164ae461730d8a8..38444b1706f4430aa6b1f0d2000d2d57b0234a25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfb48240db685b004152b61fc1f162e9a71bba43..d517f289f2218ec640bdde2036fbce007084d4dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 27c82f7d891fee5b0b5a489dcdee158d6a1b6148..fdc4e2346820b04a56b114e82ab192be3e6165eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e00255df0ccae267b1c02deb8f55de7e12346791..878fcf4568e9d739fe61f92b9d8fb45ebb9d6db3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfdfe10a0f8e9f1ce1cf4fd4501bcaaa7a38ae31..06b7c7697b498d6cfde0cf7a9249ff17ea84393e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc2d4a5bf9c1eda61313349dc33b75d56ec2d8e6..b8fb9b880df5bb2603dc9acce7e160f8e6dcca47 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f5515a3b0963065eccb4603ff3f9f994ef853aa..2e9912e8f5159b7f849b009d4ce90726c347e2c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ec38e572685c2bf87c4f3633726edc6453532eb..0fd28d63eff5e71d0d682457c1682f72204fe88c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index abb036a7baa4ec40aba5f9507e3e7cb90dab3f6c..95261932886c95f24e6a6dd7c20e85b343162f96 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74372035e51581698ab66ff5ba54d979e053cd03..9c274a0c7fbfafd73d97a7c22565d8e2d1f3442b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9dc8233ebab2ded862286c3d1ea08fb537fc01f5..15d97ee73ceed798152585e411847df79a082680 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ce5a8d6a214ac277080750fa2a7ba64039ebddf..54b2620a0f46dbfc97f5058cc4170f771865310c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 27ac44b468641e1b48e6424f74b83fdd936b0d6b..8e7b8d8740ce7922c771ae749e6226ed3a7d86b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d94f8a42731019c8cc2c2fd63c5b35cfedd526ab..a91d19b46ee33c1bf0cb0fed691a0e98c73270a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ac948ee4277a1a0e4fd2481602ec1ee204a53b0b..4db5a74d8b727d5981f3423264d2523ab0404049 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d91f294d9288e8e6678aaa7a9eac6c482f1c144..00a108336b02339ebf9c2598fdfaff74fadd8974 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c14772307c32b100140e8b0889ea1061de568d3f..f34d57503c74301855b9369df72263d934127742 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b423f66ee81dde29ccf478d6f2bef07a2ed36279..79e6c5e3cf17f709d5b85007275927807a5f4598 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d48087b14569cd3e69257fcffa17eaf6d31a5f0b..ffc13d7a34071a80c86529127b217dcf5e2bda76 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8644c8db17647a319b9fa34c322810f4f4f9d8a5..a0afc98c8240729c4920e49e5805d7e0ecb05b42 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77db9a86bbcbb56c82dccb22e8299a865c2bb8b0..a095e10244c31d817e24b686eee77cfcc2132983 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 240b811b605af78d05bce360487c6fa27cb1fe5e..3539f73522f369837f4eb0d7fe3d2cd749998ed5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e0e2b5cd50324a38ab0f372f0bf56bea86d0393..2fddf0c29ada5962690654c94ce8e4374c904ac3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9b07ce57756e1fa812d99864280eb9b94626f6d..57fb72732b7b4b2e51a51947c52403dfc8f2b5cd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f962d80f397ea34d979e3396de1174e071b9aa3..ea1aef8347a73bd40dc5dd25bfd9005c8ad6212b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 816c71d845e896432000d30f93dc8137b22ec14f..dfa879af90a3d4318c2945df21b81542b63dee61 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d252ba4c749c66cd8c5dea1e6450dec3889a693e..68a7b15c105fb3da7422102cff6874babc287a8e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 392e47293073c48a26c29cf1d90d584e21f56db3..588a7d500680633e2962ad946ab94c9f66f3d899 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed6bb3c6099b14c4e0b4c2a473357699aaab5f4e..87bf1e5ded48a2af4b5a8a1186a380cb8abdd486 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2019 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b951d9cc9976a5e5aa508cdfc607e4d561ca179..fd72e9c435dde96c6fffff21b6187c75e0c3fdfa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 306096a2456317f6fe2f1ca1d469d49622866184..6e983335839d26c76ec468d848545bdaf662eee9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80b12ed21ad3abed71eb07da568e61c18f4b66cc..399239480e794cc510680facb07acd098803ca12 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99c4837e116e168783d109e7e6b8bedfa3e91307..0a73d4ec12253d7c6d900ba5064c84bd83112b85 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d5486656a3da2abed6277c0366a6a04b9b154da..c705b1eccad776c04ff82defa2559b8185d29d89 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3be0a376b0833d1c8d4fb1fd9f34aec99cde0c33..c98bfd723ace39043356692bad50abf2a514335e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0dd9ac1e0f9c31be29114095dc3ffe0fdf0feb1e..ac4e9cab3548df98630a718660944a6aac17f0e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe8601d559ba7b3300cb38a9b2fdf67682c6808e..8cb581b698be793e7c91f76c3f7b1851b89af27e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ef503a6c47bff00e413a8e0185edfd693c2b517..9884466155794089056878c9003d36695facde60 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf9e6dac3422cd19972e81de4423f04ac2d022d6..87d10d34fe737b0af6700963f94a36838f533ea9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c652fd38f1752310a3a6b03933eee6a689aee93..d8e74dbe9be7f86326f7558018cdffd9b4169c9f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4dfe3da7c28a7b5595e543a05f8c63f7e2185cb1..4f3939bb7e5559ece07ac5356d0ce18d79afa022 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1f4938e81ca4bf1110ce3a6a3e6b1617fba3fa0..0e0815d90873554d134f820acefff9b6501bd1fe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 90eeb0b28fe417b791e7475a41e8fe2942268c5e..f9091bccbd1c835ecda6438b51ef526b093ac6db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 53041479baf662fc02095e7d6d0c6b3ae25a9e17..ac33767f79c0857f5d4f4cbb204fa7424b838a15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c29718a50b72ac1f36eb68d2c4e26c6997625c7..eaf6bd69ee5877c264a867924fe43198626ca8c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a57f5233646e35fd013ba00e3a51a2e732846d23..ba7ef54f36258861d7dec2ea0761fe0e965a5ea5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66154a70bb6f778356286da575bdf1c928680ecf..236de9e1ea21b8438e46c9c39beb5f771ae61214 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2016 - 2018 by the deal.II authors
+ * Copyright (C) 2016 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 48f99d6283096f94a93831a64856534bfbc3b166..7cde3232745f7c397c90cf144b7ed049e76fc350 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a299b10bde5fe0bb6ba7fb5d6cd0a722a9c843a..b99d666aa8dc8c064c4e09fc62762e74fc540dbc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13f4c1eced52e345ad68b5d07813b4e86285d04a..23f972c8a2aada95a240c8847ebeac6f57177e29 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c53397700f0c7b228600c590d350318fcdac8b0..6db8ad537ec8e6bc5149fbeb4093a253d239ec72 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f966f74b11d69093b5d5deeeb60fdcfd0758cb3c..362b2e9cebd6b12bb07422cf553de2790c06a4db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 492944e13a10be74883a05878b6a8faa64ba3061..b23029014af971630df915855344b70929252c00 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ebd78de38392f6990f5d07f4bc7cb353e80c57da..ee1787f08cc10ed47e43194fb54e23128ca6db74 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c3210b5fc73bb6d51c14cfd42eee95b67a70d39..2944c0d909d406b4b91098c2b0e0bfcbd5b4f50b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index afe2f4ad1e5eb44396769736b7ff4050b3aed2fa..be07865ecf44ce8d31dbdd6101187bd70cef2d97 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 554fbf2c7603565d393528a34b11bcf3d45c48b3..62eea465727af2665f1b59b22cc624aab0e8e1a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba4fa6023ecff473354bb55f5666a3351093bec5..7488c91875ca23062b42e155613356c4fff492a6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a97d02dd579cdcb929f2f203f9756a2bfeaad82..9ecff06f8118c95e9f532ae616f372f12a357e53 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97f734655d8de9b5e5cf1630eb2023953615e215..331346b92b6d540fb274f92bd0578189e725d94b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e0eb4a58358c8b0fb73feca6df6bbaee2148a012..168b084f9befe117337930a3b5286ee6b298087d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8477fa5a6ca9cd71bcaf24a5aefb2ebf50a8ca63..e6f0a8379ba8b56426e63ebb1b142dbc18253d84 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6ed3fae8361ae1f95d16ce31f2dddcbf30a98b3..32f7e82637a51b61b3ae97c8adb0cb24837f2ae7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68f77b3df26f221ed3525f8f407f98bc5bd1b40a..731516641188f4af2041fe91e8499965c4088e88 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64f52579563f1f9a357b4a068eed56a2f1b9c2eb..96c0216c34338876b6a68e60c12f5633e7e67f52 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80c3f43f84d62b9d72a0ce1768f4403a4c82bed6..fcaa33c3cf85bfd516be42d4919530855ddf1ebe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 494de74ac52e72e760fbb00090c87b7141fd932b..040b26fd3278856d5656958b7c42a4685bf942e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4728a3b311bf858bff9683b276f33b76f7160338..86fe266353614a40edcdb748578eb2ce42f8ba8a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 365bb002e329966a5af1bff757575f5fa377d088..3672151d59079fb54ea7db0bb59657967d06a0bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81f60f915aa30d151f0f8a77284b9b5677ea085a..920a6ed421f761e5bdb0632b3dfed2f0d6aa46c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f81faed719959b1a5700d1495f1353e2271b56c..dc093efa416919a2c89d60e1ed22f947d04a3705 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85c3caa9e91ffa6df2c3929e18f169e0ec0ff15e..8808da3dd3b66fb178e98d3efabfc477e2bd07b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec3e226664390d0968d469ad703896c2c0678ccd..6ed4e7581391201e46ad7638a54b5a972e260295 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4bb9d30bef49901f4b4f3401dda83b289beb4cb0..67d336d47e35da3f6f265856b074242fbed5360f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 69dcb5942e9e83efa551aca205fef3a1e2cf0a46..b027f095adb51c7fdd0d5ecc3b19a87a6088b74d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b0a4fbcdd859c84142b8ed9e41fc4f7f360e167..b92b9f09b0d9193e6482cea17633c89e6bde76a3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ed45d7decbe23b63004d42170d56d3550d550f1..cdab926c1e0c85a4818a89526907ef2978733886 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a4320d51019cc79e14aeb2e805b6bf3077ce74b..15c4c0ae1de46acbcb346b57a93b7e7a40e7684e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c689b873b8f14df7f00143a09d7676f18abdf38e..5136ef8525a4bfbad63acd0d621256e51af351f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1995cab4cc8fee8285f2a8d1d6ff8fed03fc6762..08ec1326e75e37a8ddc2314eba3d2b80ab14812b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9452be4c0f4f72117f3322cfacbe3709b004696..c9489b264f9e32dce6df2b728475932f760560ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b40ade24696f1efcba7e6d2278acce8cd4180b18..c7bc94b8f2ffe83b764968102afac7ffd0c793ca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 78a75cfcdcf5d2492cae5cbe1be9fb675148aeda..c72b0eb165f6413fc4bad25e80cbb974ea1734d2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e5592940290522b9d4c8f7410c02d209fb1741c..a53070c0a07b07487fb7c2c538a16e7b4f989dc1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 51ae79c9851887e19d7e16ea239d6eab892c2139..9ba50dfabe0d0d9935d66abf43488fb9f14ac640 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5161000f2ce424e9588b0dcf7dcfa7175546eabb..5366c9c121bbc4d3594d5feee76398a6e73627a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 09729810f848751e7d401060e4224b6cf0350a80..a5b10b37c92af51e83c954eb2664619c4b23e6fc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d722d680e1402a2d88f31fd419811363ff888d10..bc1b7029137c7fd269d186705f80dec28f8496a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84678074f079a944a2fd4e9dfa2d144140ec7470..962ffe90a143b02a4e78974ddbf37c270ddaa293 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d9df34f06334f9d96ecf727859e57bea3d8ae6c..d2109fa25ffaaf6f29203f9dfb1abf21e19cd565 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fd1b1fa29b6b6a673fb449e7bf5dca5f5044819..0f35a1551d0c9f10796c219a03b84503df723e61 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3bdba170d66346470cb82e217b733eccc490486e..0d8da5bc12af2f5c40ef2f2e57fa3643b3d41688 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cefbbc02b62139b191a7e205ea97d3270cae1169..d5607df92deecae598b648825c80e38271348426 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b3e9f53147aae04435c53d512b5afc4d6dfc381..3a567ed39ac49a8dea2cfd15a720578c2b48607b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31d79e2d19fcbcdd243b68e492d17313e83b9f82..cf0d195dc3345b013e09a081aa0064ab1bedfc82 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6951cb5ed586fbdc72a329ab6a2182dfa8d78298..05cadf01ded25123bf0f7391ea23b1fa9809a501 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b7279e242aa95c4b7934cd6f7fd768fb42412c79..cf76039d4ffe620087a4f96a78e8e039969a3832 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6ace3c40db3bfc07f0f1c0ca57abbfefdd5aea3..21f36a4d77ee07d199987f5b81b518eff2c3cadd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8a5e8dc4049b1c85904da2d79147c12e52391389..a71e01647b64d89ab25c43053f16bd7769fad19c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 683ae7f92dec118e59a56e4eed125b867b1d255d..7f38a668bee871b6231d1f353e07a3c84723a180 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d101aa7fa6edec74bce2e3fe48ae9a51f6c49593..c1c04d06abe9294905ff1a2ff014a46775be663b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f317420ed03770131c6566d6ee68a58c6a7368e3..07f617210ef63375e7fedbb403bf4d6dfafda986 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17c77f880b2400fb51c4006233d758b83f3351db..092b84b807da6cb95ea5b4fe23f17d78b1a818ca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f20011f8b2a76261ff0789d1897c47319c1f88f..d805a4c8fb15b413e6522ea8b30465a8e1b501f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a37a9f861b2a28f46db5ea0b744158c44fc07e65..d73aed6ec5ab503df78ee2d852011f3b24b0378e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b65040e71306edf73f43e162bd702dd29b00607..a829d9fa74dd79d294311e979f49c8a83ce81d7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb8df8a4543643da4dccb961330c0f75b1bf8d80..bec5e9e2edb6c05bb70aa912680be973f6b725f1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1be791e40fec96c057d6d7b735e4b91e1ab63c94..f6e7e14c0e0f515298a951de406a4829cef4c484 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 427e81d6d0f94a66a6057b1938cdc871b369d0fe..a7668bfc285f7c7365d0252242a29af3ad66b08e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd8d67d9966dca8d3a06393b169be8786b322fda..0402801cc6a9593e913b3047ec2092761ec206a1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86270435005d4460f411d91f2d79453eec994818..c272c4c23b663c37acfc60b7ea999fe004ffa110 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c22a11e5fc9dfa4a821c2e556dfdc62f9e28da90..d6c0eab843ea38fc5c2655a58f2c50cc6c91dfe4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80f174d3b9577f6b625c3261574eb8ed72d202d0..a68baf12b70b59fc36827d762c6181df618caba8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4c683f661705c1091ef0ef396379c3667ce3002..d63baa05aec723ec86917d667e8442bb33a18d25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10d8ad2e81198cfea778d3e09c185f1070fbfd3f..23b13c997c54ebdaa5a49d5d216797c6b8d0f837 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95568c013d9a2bab666d253302ad87302bc73168..b02ae9466e0f710596439ab143355160503ce490 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f957134a5d667608d16d235f824dee1f44005899..7ebc726bb8ff70c760bf54bb7ce93d3129247e83 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8fefc285e70b367f999fdf36a5ae98fd2fba60ea..a98fb91a5fcf927545c8ef83c9c6a6c82bc0bcee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3572a5ac6cabb0143ca70bb238a5ec616d6bd6fa..e369c6d8009b394ef1183c17b8f5560ee74686a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5db1fe1b2be62965b0326019b7af00555262daba..a363f83ce18e64f6e51e72fc72b2f4089dff62cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6017e4da4f514e5b99974b4a80661c3438ad373f..31571384d3596aa5b17f7e04533a061826eaf55f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3df9d83545fdc9a057c214fdce2d87b8cd6a604b..1acfeb144c2aa58daccf50778fc42cfcee25b093 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d7c7ae1f84a3a1b8317d18120e9f55c0e72e054..5dafb8e85219204150d8b976f4290274a4d23735 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e554873630d6b455d13c47e671fd7e06accb77a..6e26b0a0fa776a92088f48a2a856f0fcde007efd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a5371a3ce24bde181f82b3cb6a0a3b5ce61d348..8e44e75fcfc53e4fc958aed2e4d04303d0d0959f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec4736317fe89f4b3f8234e7d557fcda253993d0..6e10bf3e1f1500f2b3ee19eb8d2ee198b53b2ee2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7b6cb6afbb461ef3a99e2b824579f9dad40786b..4b3d6706a49c57334336361339a1ccabc5e4d064 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2fed59e2bf5b3f1e0a442fc34d2b3198c9c15a4..9bd96014a47f536db4de0220a72ee10141c3e95f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d988e963d24f3652c68e4fc72131b990603f55d8..be8fb43266f0d27b24de5046be0dcb26b8f0143b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 292043c293a5ffb694c4bcb494624696169ddab8..7dcdaac230841fc1122790963d08938a81f51dd4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index afd9a0175909fcfeaece0c3e1e174a8d20b70c15..390d77880ba9a4dd4a5d5c46fa131edc0efc204a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 90e5178aac67de10439f7bdb9628a402ab2995ca..c41d1d73758bdae61074c8e6b496cdd31880dd5e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b37de778f60aa31a52a59ddfb945c7861af69c95..e9b81abd0abddd18d59570eb8057b52ae0209126 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 53624c2b4fd876f8091a134d177b5fa475c93a8c..fd6bc62b51a39e5d044b284dd7d300095ca3c723 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 184e3dad4b9298f8839cc68eca13a8df70553cce..ca4794cb402ded7e8cb9742f6b3d65261a4a89e6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e635250d0ef297d181666abbf54a0511f873fce9..4ebd6881afc500d0c0312d01c6efefc15b4be202 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 311955f8ab442151c67dc775ab07d77713bea245..db222895be0d7cf292dfbb21be122b5f1cf7678e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb450b9dfb36bd4c5176b3d90671dacc38b82d8e..9bd366b470b68d25213cb5adc5d35e876c5bdb2a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9ae2327e6230de646b72f1bd89322c4e62f3b707..068493438e0b61f9545e7dfdee9117de6bdaaee3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dccf95ce7766d01b1a26e58f09c0a77f2c832989..12f2093abd70bd6a797be41d050031c8a38c90d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfdba4fbba5da3154bc8aa2512ce510a9af24636..c2f3ce181a3e58ccc1eb81b29b2ae414baa83a2b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2f1ca9dd7b5fb511b5a05da01a3d790ce924b4c..e6b54a6dd232f53652e7819b9bbfcb71486d0cc4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21dc8784a58721840207266b04ef01caf9a3a9ef..8536cafe04435b127f816f6c7722591528049f18 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0add928260a2339b19222d3dcb85a59f15608ae3..decfa0c2e272f05c8a3a732d298fb893414dfd4e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38c79aa84e17d2aa390c5bb06dba12e27745f634..201858b51b49b7efa20b0207e7b78b85c38ff0c9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0ac7a98f421a53131d0d0e22b5fa4f113ef3fe1..a291980f18183b105d15556378dced655e9c2b6d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f47f8d7de36170ccde18ab922203a76c2660449f..27861132f133ce71f585d1d7f0cadf0dfe40c73b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eabd3afbd227bea259c801f5bb670f57acaaff2a..642eb78ce0bd111e187737ec8779585e9cdeaf6a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a2f8b0509e35f6357f48090903df8cb3e1c9b4d..8ccbaa22f395851c1630d1829192999824c34ef6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5091d50c42f06c1f7c8899f590600ae305c6240..ea509a5177643b8c246c1aaf95173bf7c2741520 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f669ee5310224cca879f2586c63e554054e9b186..25f383b865fb9d866c13440e1f5a50800a394b7c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 24569204582985bebd8d8505cdcf2b681a229d49..244fd822f9cefd9e07f64840cf07ee288e80e9af 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7d1cc86bebdf08db87c6dd53b80dbaf401e407c..ac12fad6e3bc9d6387886b9dd1ac04e4b1e43912 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d177cb48fd9b0d1bd63c4eec6ae0542798ec30d7..b799d89885b1740c6696512ee77b8c04e2a0c82b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55ed223edc23f1875cf5d45c655316a8811439d9..0eca0d2fbe2dd333df2b33c38b1fb00aa0183443 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e1e97010e35093dad7d77a9e5d3ec9b6f6c38bb..6a8e929b822843d0fc37ac21c659982b9bc65119 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13d9f254312c3bc0edd824748b3170b9e7ce78ab..0f58d9f52d04a0ef7431c61cb6f90c8097196018 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3a4224a318e2dfe285d0e35bdd03c85d6ebcfd7..acfb352f4baca0b4f41a5e1d365f0319f58d2cb0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0ebd4c984c9fc764436552f964bc744c7f8f64f..c51fe56e1fdd938c88db6d94c6b95f6ba2227722 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c64fd11e63a69df1f22147d2a0d41f4c15dd856..ebaa740c381e8e84f96e760181f2b566b04aef91 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f9cbfd5cbce2bee89c0890f25cd6beb54ca9736..126f3964eacd7135f6b8a1fa3453ce7614cbbbc0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2017 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88abb38187d5eab9c432950815ae8bd03d1e5d11..f6e2f89fccb6ac84930ebc0b9b94845bd28e4e9b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4e8c3d2c50a3b184bdbe77101dcf89af99dab58..4726bacb449d0c2514f8d12113022341aedd0b5b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e35a01aad72e55609d1f0c8355dbec2ba42b563..e4f85f9d01ec8bca398af3ee21cd8d979423b4ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2017 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6e8c4ff6878be7e23e7499a0038fab76d5bda19..5c495001b18a87e6f788ae6b10681df2a5c3efd9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e560a8a54799a593300fe015fa4a0d879e0c9e23..b4712718474c6242b6cef185382a2ee1aa0de7a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0dd267c568ce3f8d12124b199fc8af8935cc1b62..21533b4e917e16834cc31d3d9711e78f057a1e3f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a5b13a1104cb8df47c5296f86d266167b9e13ee..e308030124c0007ab8ab4a38d30f8ffb879977ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ef08ca3a48e3bc942c2091ece7e6c6ec0782b7b..021c6e4027ce2c611515b4397adc50a692aa05c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b87d376b5628656a1a2729908fe061a73873526..1016facf7441648c5ff91360792598e93dadbd6e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2017 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa37c965a5ca82d20e217e0b2d81fc93c7146e10..386b0eb92c20815337f39d5d9da28a689ba4e389 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 77ad5e87723f4d5ea69ec626803d531c0c8b29a4..e1f374f8b458a994e47419c2fe9490758a6e6a45 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c155b5d1a93f690c8643c77fc5de497f73e1b06e..4045664482f89408671d95392c74c05d60f52e5d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40abb70d4d3450a7d3edffa497db7e0657f30d8c..1f28564040146a2692721114528e151df11bf915 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4fe1fc530631e234129bb8df6b971686f5e3725a..328da907646c0e920e11c4959d551947149434df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b63cbcccbb3f4a18b409df0b098a17558716618d..d2c3d5d065bb04378e3cc1e4edfe6428b2000bdc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a51b4fde17ba8de95ae9d842d4cabbad7ab1f58..3e5c0acc647adcd847988d9fd8c490b8c2127de0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48be2464c6033d4be608eb4dd3bffd36ec800c76..9365116a5299cf3ca069a097614ca2bdce94e2d5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfcace8605846295cec94dbaacdd1deb81df4e22..eb64ba8ad626dbcc693643db96a91a4f7845ac24 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32e16b4c4446e543c128db85f6e9eba3c85b6201..9c1e61d508b5dc1ad7b09fff581603bce3693200 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b40e594e9b6e9f3f4386883334f55a0cf6debda..e8f26ac205af13c92aa8dee97696e9730d02c444 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa0df744962badf89e27e07a95bdc22cbdb6fb80..7b33449150ddc10348502f3465bf2a5b78842e36 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 1999 - 2018 by the deal.II authors
+ * Copyright (C) 1999 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b216d956bf5a35c714582c8b2b756e5e0b55d931..2b9e62a799a59b67250a9ecd4726c0bfcc6fdd8b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f221ee4c75b2124dc92f5af862c6e67280e21ce..58c30cae00b972fae0d1cbe16cb40cc7225eb72e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa016d9b0ac78bab6a0e71baf7ac19536a5f2714..17e34e2abaf616d44d96b960938d4fbeb842a275 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ff447428ff6ba919feb851db597b919f7e3927a..0d6da37fadb0a31b3b0db11c8ef2a450ab6b2ca5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b9f08a539eca4e377d184c48d2ba750715d9d72..d4dbd2f56cda80795f16927e5c2d53c498b9428c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2017 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1237afae91e07eab3ebff902759ad9d5098a3a16..9e017ca792559a2e3c1c0e842fbfe14ba8330308 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fb9f2c26bafc07b98c16474f5a6c632afe8f0237..a28d8cd331952e41e4662b68c3cd30af4d60f07a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index efe7d46a46b1820ea058eb362bc5272cd9683101..6a2ecaa00e3cd459aeafcb0e16e6bc0607845d05 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2017 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bcd3e21580c5646ef7c0af948021934db53df14b..a7564b4218f5bba391e9241ae3991dac67660850 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a982895370c898c373bdbbf7787eecdab08a2f90..c0c96237a114e1be857707292aee642ccc82292a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f66ab0f31ee36e53b2a8ec5436d4b851920afd93..48bbf9bbee64a0510d60e1fa33e880b4d11efce5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45e37f4539de5a0efa46d52de6a4abcfc57292ad..50d39c81ce04be97c25f60a2d4ecd5a0fc7fbfdb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e282ab4d0752d20d8538bf9d736c47e0e8742390..47bc0ab38c7a985a146431673d3013d17a9a0f04 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3828e8ba99628cbacb914db617ccd06007ebed29..05fcc560fc97f5959fe07996555e54fcda1834b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2017 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb422c22e5e9e35557bbba25ca1457a7afcf06ba..430349d7384d3bfd480d2f0b2b49040aac24831a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4626c96e8fd32ad3bee53db4d4a4a3b93373712..75defa65c259a06812f2c6554309df0aa9c93e17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ccebcdfdeb33c92845c24368a9ab23b57748b3d4..e8b537e2933d82c44f21b1a7c66b0816ef1aaa90 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9edad8580082f3624c54e8664eae64388aa2456..0dd1b65dfc1d530abfce39c62907c4164b85d52b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68dce1e122e56024f6112354ee5e010993f707bc..d96d00bfac071d7828c10ddd15a284cc553bfebe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18113b8a1b11e25d4323abb5ca8b8582eb5f8f9b..a7cea17a7b14a6f7b1951d4cb1b14e83aa5931d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 849635b11b1b52307b1d42cc15024f57e1dc507e..fe468db8f85b6661a7e11e8bc956bbc72ede25fb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4bd62824592e5787cae6c8cbaa58a5865fc6ebae..6fcaf30f680dc68b8a5666ec40bb6996fa978977 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 413025e21228152eebf7474e367597ed0089ad0c..0351f6b6007314123dcf885ee5e81edfeae96f85 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1303af94710b12e2596c36cc57c366081bcf57a8..5f0c565149911dba04729f8cb3284314b6e48e7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9931a78efa6f2e42216e080db07294b9ee02bb6..2549a982af6e90bc828db836705635e7afce571c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59370e79938fcb40c66f3bcb34476711722dbbcd..d3d1448c1c0d5757d66e9e0f88507d8c80fa5b82 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17ad680f503572ccdadd227fc05ae5aa5b45df85..9256a9c2d7f60840a52fe6fd6fa1d77cca85b2e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ee1eb425cf4315192946343c9f51f51252e76db..4ee1807b591e457d512c32f535e673a44e0425f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1268015565608f9d42178f62e42c7d823c5bef2e..c58351e6ffaf8f9382665eec8967d0dcb9486b6e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b2cba1c7e63e42e00db0e55af15e60273c2159a8..e75cec9fdcd583d8f9adc34dbd41725fd59e9437 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4fc46b6e3a9bf228aa3c3f89efb2956a091c40e..b5c269b08bd660c6d6aef28045739ee42823b154 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63f87448b19759506dd1f8b987f9a51b69495dfb..f88adce0ab30406875b098c8cc14d8643f836c9e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e5cfb6db54c132d5f45e01dd6538ba9eb577e5b1..e600c578cdc0e351e7faf0e09944350efe14d260 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b38c7bd78fb479ebf94bc88c75194c7c8c013c96..d2c3cd1a061c664e01883fa3dd4602cdc4d931a1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c8fa35d8ad11cc4f717b862fcc855c24b0b551d..195062eac059ed2c188a5cd9c49ae40c2d8491d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ec365bcfb874e518dfb0adce2c4a073cf63dae2..93c9f5ffe2fdec86acf31c5574703874b3eb93ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2017 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d54d6bed3fef22b7a4eb033362a4bf0b3d223ed6..7c1979d538e7e3e1a3bdc38c09265ee7efb8992c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd98924feae0bc4a5b82cde72ea21e0642999a50..5f4943332e0274b4736e81152bf5ba7575203536 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2017 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba43320308f95595ccb3dc018bdb004dc65fc24f..5c2a4250a98d1fd9b8cdb0e9e44973d53b4d4a98 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b2462bdaa3a1a53867efae0d29bad0fc9ba448e9..a8dc1a0a794484d287741ab9e55020be63da4b82 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec412c1db499c5a85ef5e7372a97239090c8bb53..f325ca9d146f95ce7d3f91741ca6d685c99c96f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2e37c09f1f5139ec833e9c7bbbf2317ec940c61..e55ee9d6574041caefe98a893bc47271e3a1cbca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d003892715e8d813dd11c164e3a3d37bb6276a17..a4160291159670646409ae029314c61f2e891eab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1dc9696c6a33cf2bc937eda70694324ea880ff5..ff20e4c479111a0d067e6d3c550073101b9da68f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2017 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 76b831ae0c5fd628211c53a6efcf133abaf86596..976f9677245ba9602ca4eb839ec9f6a196b3bfc6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f431cc50d0f80c32f5efe42e2225ba96ab1793b8..b3e8cf84d93317d9bc230e0531cb0bd097ed8d28 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3167b5b37ede1e039a50a80cd11e164b35b9be64..51f52bf99102921039faf1a81c3d1e2d934e327b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3035d6c61230387d876184f6b157b6353bc8065..0d4d8f17e3167134646b377c2600580a1b0be85f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8c10b90f5b292c644eeee448806de0a5c72abc2..a7dd91c843390236ce4226865ec7da986c0e3848 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af5f29a825f29724064afa49fe161442b8d5685c..cbf39c739bafad942193bc275b729db0c19c5677 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb7f3d46874199f224b93169d4f353a6b74e350c..9a1c3440fb91920f136f6989fa74a9ff29a3bee6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6383076e5eae87f3ca178620a589ade0199c109f..af0f082e3fd96e13452aac5514c9b45169fe732d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 423749720457a8939936c3e5b3bbba94a4d94906..8d1930ec77ba452908fe472d7dec215c5ce71142 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f151b04d3daa46e7b887b0a6400240cdf032c578..a081ba0a6959df479ed68f0c8b018c0291ebae40 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ba744632ae85d0f303e73a5adc991c100e5085e..ed706003e447878e8f756d1750fba562d973385a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ac679430324f5e0435b612aa467d524c50b3d48..dd83f1a064ec975e0d9ada60316eb35e59650fec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ebeadac289bf21a303c2eb84209470d81c66138..5a0d2ef2d6b0b271b902d6f2e5d1cdf88ae5782e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 27719c29f0604ccd13e38c48953e66921fc59d11..658b0b60df3c4094e3a7e53a36daea44075d9a3c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5e7f6690225b2fa360ee6f58a14d65a76dc0f1a3..d0c9c28a17f327d530cdc66307e36c32898aa5e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef722d8cd7126e0751c2fe1be5a193b2d04a5d97..3fc51f4eb99579f45a74894d6114b93506655065 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 58b706a69d1bd0a1b0cc9bb78cdb21524cad6312..eb2e0c411f821fea3314bd5e7755c635c41f87c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52661e559f88f6993dd4a33dfafedf99aa1f1f9e..843152b8ad4769d5dc06b78fc1ef8e6c856fccb6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7682ae65c3080462215b5edfd93f13d65fb80f2f..029ada7aa604f3fdab503dffb5019ac02afeee68 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dac397d4c24d2f4d0ad1aa4c5f39e8a090d8e64d..1f3678a9739d0df64fa2ff5f1157e3d641aaaaa5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1db642e4a9c62207e3cfb01c63f7694620049b21..022f21a59c20ce3c601f857b6d8c88af80e2c384 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbfee129cfbb9afe2c6fe7a7bbecad5842be4711..b11e09ea13f69aac3483aff9518fe615fe60c2eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aae9fcd18b7ab3bffc2bcbfe9812333f2efbfba9..a41b8c0916ef5835cffe4f7969d5827f0c389e53 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8830080b629b8d956fa9ccd24b09845762aff63a..dc24a02284b4b09b0dd1040adadfacbb4c90ce45 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d49bfd85c2ea999566fe69f0f029f76ec17463be..7ab83b087d682b89cf3aa256128cc0e92a91c99c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfe9fe2d5f562d08151d76b3fcbb5c585d7768a6..5c94c657341b385fd15c011677f52aec7bd67aaf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 272c05792b92765f19dc6a824a1ca4d5998804a2..761911e75110fee287dd64112dd865295950e020 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 202e4b3bd09bdf7a480c6c7bc6b0bff6acb1d4fe..aaa9119a4b7b3fb79623272dfa25ce51503a5c5f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6223c548255e81cd8bf50e1788b1e4704f12cb61..00fe74c34a29bf31a0e07992f2d58fff35459bc2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16eef00a8aa6d9c19e8f31efc0ca74765acf905a..ebcdf416de36c9417934c8ae85c084bdbf245948 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33f582cfe9e1f21d7c07fee33917d9bd52591c20..055e7b3b2823cee466564fee2857f7c7c2cf18c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9290cebf57ad730255773cf9a411aaa8f1320bc3..a5785f17fc77725c0c6706d024c9d79aea2820ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8a983d059698f0c190194ca0af63a2400f2a220e..cfd1ffd790b2f8e8e5385ce7a5a269b717ecaabb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8766887332d77b7089f7a5ccc5f3cf897422f165..b3f9d66d756cd71ebb4a376b2b2389771f5a0b8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 573438f541765c8c9caa097a89f49545a4a729af..4c0257f1cfb53defe573d41d7acc16e13a1fa9a3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f7e8271019886629037c049a2b43e7344e2dfb9d..72a55a3888633b05dac3bfcbd54200c7dad2e44e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b16042cf28b12e8c0eb18a3967ebd5c2b8ecb40..9850c16fe4547aadf44204e088414dc2819d5836 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b834b6c6ed52c2d96f9e83b1996ac7209a40c64b..cda563bd1dd7d5f360616624d318373e9a30180e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52ca56c42a813811c89487c76fe6cbfaf7706b86..84c2a1633ac777aa53ed7dbc77a276a03bce877b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52d0b582070fd9dd21278d0cc4930f9971a35964..f8e2c3f8b9f977855e9548d9c4655adde4723983 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ebf84a201466abc12b137f5d7ba27ac46e7d549a..5e987f54aa41a817ca5d56894263fb5407cc1ad6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 19ce32dcecd6e6e961cd6e6bfa9b466c0041bd60..d6252dff0b4df2525f6ad06ee1610ca8485f0fe6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 162726df619ba5d382831f14ea1e27cc27da22e4..2c2c8e9cd8abd6a6ffc6d25f85bafdccac4b938e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a96f54293927ea8c703664d48e8bc9554219030e..429e7bb46aff5cb37459829593b8f0e5fb30e879 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31ef04c07189f9b491adf70eddc997c745333f4b..71dd896d0351b5204996c7ca92a89ddb3fd35249 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 094da04ce1e1c5fb1061aa1399374d554ab49f68..b53cc52ee37528207cb9bf2adef75866b5cfd03a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ba5e5322a8b236933d110608fa751f6c3c519a0..122eb4a4ee9d512aae614c6a3f5506cc5e88f0da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71e73f6a9c1428e3c8637d8a51add7a741aa4527..67ef9689ac19b4c18231e28284abdd95867923da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 014f88d32b6b028022f4c6577d3736ae43dcfba7..4d23deca696bfa68ebbd484f2dc6af2383c292e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d945c90bbb5aa7cac9e5407ce80b8a061c6d39b5..42daafc6b9b9f697bceed77abe8b9f8508dedee3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a85fed70f26bb33180ff75b0b2348ccdbd7e4ed5..5911e0ac7bf6e4375a256358a3bdddf5fe01a8e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5f76d10163fb46b150eff2882b70961e833b490..3819aa93fee008f80193384aa647e761adea7f54 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe92a7d6282e42a6dfe8db0e7ad13b0d729aa4cb..929726dde0c8d5a994c54af7d063976ef3192134 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8828f130bb13244c996e5e548b43f2664d5d1bf..2b7ab400cfeb8607ccfdfdd84d3877bee7fbf8d7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75686a24463716484db96527afc9177aecbe95ef..bf6f15ce847184e5ea4a681e04e5d006557f783a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc993f9efe19c73eaeba279c700fd7a5cd8079c6..451d4f0f57ff25536a992b6037bb0a0b9972c737 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9ab030337650c40228d7ff21bd92b2cf2306ba54..e7928213e43a2d9c7e1123d26fc60a9e00b60cab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ceecce7080ca5624fd9bfbbef9d02f4e5f4f43b1..5e3c35110d6184d587c83bd33f2a2cf255ce2eea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21dd00b9c7d74c171fcde648eee985aa87317236..9059d63635633ff2a9fb7a7c4181798321ba8ea5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 705bd2e10409b68cb5495ab906b769438dceef08..adb2be8417f6660c02a079eb230eb049e04212c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57ff0040a8ea5435947856cf8bbe988f49ce7b19..1b6a10b1ece6e8ba2311bb2fbab5513eaf33812b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f34c3b92a2646be77dea089db4b37b4f504c346..5ce2b14c97951bda9a509072b14df3a8ab711708 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f79c24a6b6293dec991155e10fb0acd59cc8fa80..47e62cd4ebd837e0586e82d6b59a02e7382fe137 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64107c077ca53be7a1d67577bc642587e3c25aa2..50e61f4c610d7d75e528e766edf9259ff7b31987 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b06ce0c3ad4981783cc2416d40b9b0890a7f4e5..f8d5b3957bbfaa919a73db44a1c55663ac758d3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9853ae65a9c91c18d26ae5a7f7da3a4d526ccefb..87cdd88cb04567290e24e0760ee326d725083377 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad97244c74566b22a36fc5c30d94c25a56079db7..494facf1fd0951147cea5e1232596bba51fc378d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d63b2f0582ee815355a9c28e500136180f40794..c502be9c33d047121148dcb2f5c41e2e390a28dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e926dc12514f1c563b116aaeab60803912a8e76d..80b21cdd6ca9c4ceffeb7adb9a645b7044fcdcf4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7dad82287a2a7f6d287faa181dab14f9cc2808f8..77706ee5043189c573f05c5f596f7a361826baa2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a8086fff6579d6af0e635028359fc096e860abe..56c2105759938e12dce96246f052aba5e9a441ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2eef07edfd113a90c590ae70521e4d8a883dc86..0e0def791ce3d45214768bbd1a33e357ca592e58 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe12246b936ca6dd1201f56a33e0c1c0f1824bcf..892479f9c0102e19ce499192db643723a0a9c93f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b185b141ed2b303478bd038da30f242c99491a3..23e2f2d5e7deb3722a8d659ac4c2e702430fdc05 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee6f7e3a1ea933e289c189de0b709a4cb0e664f0..3d59c9f4c731f68e78183239b3cb6133246ce8e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4bdf0cab92e6304fc951c8ee409f2e5012a05aa..e2d51928625641d55f16481cff306d1f2215e98f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3bcb2a6b1c54bfe0999d901c61a85dbeeacfdba8..11ec44169ae45270ebc650ed8b53c6c0c845e987 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 512878d9b9e90c9c7a0d32df821b12ccd0129985..706f167ffde100da27bdd3b2abbafcfbbb449c57 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1925a55afaa2a03c866eb29f719759a9bb02ad75..04a1250e5f7fece59f2733f0211c4008132078a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b94c637da14c93579d293fe2379b6cbdf1dde2b..85633e0e77bd033b9bb7a9a9a6e6c79a0f4addef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e90ab77adfcbe7088baa6e98a7f74a7e7214ada6..8558f00e0f0ec85ee0bffa27ee771159459acd99 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1910e32a51a550b584a253cb70f4d85bca24c2e8..1e7413ce242ad6f7552d71693911a861302fbce8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f7e5f0d65dbed779868b5a03b03007070f93c1a..bd41e0018d3975f4d8a7b87a92df7ab8cc0c827c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0d4770038e28522ad21021f17d2f01b2ff72a52..82f17deac5fa3a0ed6ade1327b03273a0ab3c00f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cda834088d994f546ab963e08a371267df77da04..2feb06f9ff6deb41b5171fad04b3b74e30fe4cb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab2124719fcee9de96106c91aefa73c9c8fb55c6..83010b1870fa61e0fb8a32c3ba41e30a6420cad3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9beaaed4e472a32a27a01c38bb2c9fbae38b846c..5b8a0b2e19202e4943ad1cb1e86270761d8f6a61 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 56f1c4437762e80d05d0d874ae3fd3b3743fd015..b0925ad0bbc927da1f637a9ab5d1a8b0c1360660 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fac57ea35f23c8d64c3d3513b5fbc5f32c3a3b9c..e6cbaac4568ac6847d14921e53cfb983dca1e15b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31ec5c9f6bcef683bb9d6e736cb134bae9d6ab4a..7587ca700a593274a6938f9cf9cdd59e2f459110 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a22f055b128e602e8d56b65e14f0f5b38fd980a..a45203878796e8cb648f9632f32d6bb224e6ea11 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39be71e63b1e20ec981796a521022ac216d1efa2..340eeaf8e34ad53c7a4bec90d63888c5b6b05e77 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f593fad59bef4880d2cbebec928df0f947dbbfed..863aabf6b1bfba5412a3ba1c4c08f81568d0ecf7 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 1999 - 2018 by the deal.II authors
+ * Copyright (C) 1999 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 2b1d5356857a0975056c2e56f84fd7f78bc23e1e..362d06e99a716b6c1389c3858829e827630a9d80 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a3563266bf7f1873e6159344ecf40c9f522f27d3..7ba82382b280222f77db59b12b4e81fb573f3d54 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6c21676c278ec25445ee2bc675b51b64de0bd2f..b4e8caff81140e442522889d49a11965f9b8d15a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dbf4e82f48b779cd1fa0190b02d441e3315f5368..e7460b34e03acb2788bfd10b8d1d3acee50dc7e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec8df162d8104b0d731d378b3fc1c55eac2059e7..0dddef7ca18fe719e196ab2140180b5ac2a2dd3a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a45fdd667ad620210cd5134a296ac3ed1500344..903f30b80473532b95fbf9eaee1d819eec6b6854 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd94c7e07022631393e484bceca15f57f8f30226..65bae6dfe4c27b0a5d8969e771eaba72c4fa2f44 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75c0bdbc18510e743334e0d9e18e567d45a37bf3..b452d071f156533667e6b4966c657c8655983afc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d93bc9561c2c6cf2707d025bafaa9a792a5fd44..39533b921bffdc485a6b7d4fda25e6b9a0436c00 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 957c56f2e4db6a5692e39c045ddc04092bdd6c9b..6b9ec93cf2596ab572f97883a8c6d923e1b97543 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a2552d459b44324d537794627e03c9acf57e495..4d745aa1b392c9b2199092438db15ae0aa44a712 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8d735e2e3b819ec60e8e8c08144cdaf98d6f20d..1172d64f45dbd7b94a999b649ff422fb01e57488 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f2da3239a7b2f78f5107dc9b58bea07380d58bb..1964ca6461fbf958e2ef263e4680c0841e88266c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8af6ae1cc458d26cf033d911d557c6ec3b2c44d0..a40e5469a5d9c25a833ccf2c63d166771be408eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5711009acde83990ba7dfecf116d6c2351b302d6..60d31c455a067cc62d7c0cec99e378846950def0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a669838f87606483b111ecff1c309a9cda2c9d14..ebcbed06130b1571395effbbd2291dc271e49d3a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 160fde45a1844b8d561d421af2673c05a2cedc9b..973f80c06eb8f82c76f0cb4fcedd501cef7d646b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0dcc5dffb587b766ad181438124008b5a56b4bc..c37beb5c3e84bd42df92d3dfb85b17bd91f33996 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9feb2015094c7528b7f5ef0bd85036b46a691f14..deb0aa5e7a9d7a5394f470695f8bbe8eb26cbd8e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c9388720b4cde43885d7c0799eb106a0c67a49b..37d38023548c02b743ad1146b8a31cf661c6f0ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7426a862a79e971063f53874a22f82a095d97b11..869752687925cf5566e77c5df76044d205ee7f65 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5d6c5861c671ea6955e8904b6c141dbe407033f1..62c8f791c731ac6e7dda802e7e9e55def13fbca3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bc6fcc9befbfd9957fed95047d6784587a95ffc..ca70ba3f2e85b14c968f116d5a99e67f046346ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d355603e9ad0ab0f2635b411692819ab27d6d10c..46449a108eb3adfec0af1a7f51d37ad846c1320b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cac70613c07fcd260e843222a2c61cb8cfe64fde..beecec988d317647d10b7adcd92928865b010c34 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79723bbae82936a62d38a48a62f2f268adc83857..adef34aa888662ee80ff980a2cb12fe29055d25f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e56e00506360cc9bd9224666f291b6e4befb062..689f2be36dbd2632aa73c7de030984c08f68b5f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16eed3dcda8a4fb1e18bf397a587e47e021917dc..01d522095bba99f6dd567e80eedd8ac3f1667740 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9944d45aa490ab0857d795856d619a3149008880..bfb923052f5834ac2d6326195fff6e619455186c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4728788964328351c73cd85cb53a05f7d1437c4..4350c9c97f17516221b6460aefaa070039b8f9cf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b48358d1686d9cc14a90064fe77d7a6431656651..f0b8dfdc84cf52133df8819e9d32224af49309ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32728b3229dc08cd2d5a376c1a2781e2abd7c545..f38bb06ecf5245d3dd15d3dc5ad78d689f1ab961 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab9fbc217b2907ecd82229797d70556e5bbf6aaf..cd448e3379c4510b7b688c1d1f811c2746fe5d6d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a419cbfcbece13bba2a63a9d3f5bc2957d5bf23..dd114c7ce74746da0caff02ba8b1d3054eb45050 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 354fd7d71ecc13650c9cc1cf838448c37b4a8318..ce696f5f8bde9b158f83ba5da71907be786b4174 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2018 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 7727ebc3661f48ee452421cd1fdc7fa9d82df068..e78cd9ee622b53a4b0c614d09f0161c3fb8c483d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6679f9b2fb97c34dbe0757117f3fb6fd92f44000..93dff90a797b2448f8f077795d410e3db214caf3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22a06e9579213e674c44b0a74ae54605ee74eea5..b1b7f25131655cb5932ffc4d3db7247f344141e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9078463f1bbddc3f5cdebe793fe9832118c2eaa0..eed8bbc1963812cb78328a026013ada6e9058755 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10781200eb17d295c5c17d20f15f22dc6c540e5f..8af230f0b81a27a55e4d424470fdc9e988d390b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34688e6039a054d53539b6a6bb6d653674ddb1e0..2c116777a55a7cdbc61c6f772a2874fa1f57e16b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa5fda445d6508730ecf2ed15f8a8636d7ffa772..64c872ef7c249cf8a75394c22228275f757ce38a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e10d898ec669d144e47592d5d9c5ccf5233fea6f..92284abb759d5aaaa70bde6d74e2cc6469d0621f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cb5f8109c355e9b0276809026a002ca8d920f90..b4c04cc218dc32ff6c7b96b0df43c0c000dd77f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc27739ed7ea931bf845283379ee253ba4151f16..72765909a494fd2bc91fcd55c6f7c1559e183892 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c470abca9e4201c57df81f9f0c65825e3037d4af..3f1bf6d8a4cece21ff8102e2a447c073100287f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33de72c57ae3b633d096c8878dd3fc4d9b76d878..b62c2dd48cad4d7c76f33419479da960e0c8ac0f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1888c6fc54869d96dbc6f24250ea350920d7ecd3..853795bbf8368c7c6c3bd2b7140445a6f5d1a60c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6e893987b874af377bcd56c92f9904eef96a52d..83ed4c15bf0520139282312c0856fe199ae0969a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index de1e0c1865eed3172a1ca724159899b2260bb262..bf8445e4499be9ca4b536a59de2281f09d710b48 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b133a2f9ee8c4d634b9eb9ce9ba88ad698bbf1b6..49a34ee20115943d587682d9c930ae041d83403e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ede960bd5fc1c860a7aad2bdcb01ffafb8e313a..6e982e8b98b75298f3a51be91016de86c077bf75 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fe0ff67be7c55de108a80e63028423e778953bf..ff1aa3285518c42feb86eb61c6c5420c666ff2bd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b962f13fb42d802a4e938a6f2fa0d45e9dcc00bd..2ceba9921c80bcf3e252394f78129b1ba0870967 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f9d0e74924874740b8454fdad90a185d66733c9..b51c208e5ee8a37a8e6981509dbdfa7b5eb1a839 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2bb70d789b69165b4a443d104eb1ceca0433a11f..7288e4b45951b25b718634df81028518cbaff9ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fffc8a6d3035bfdc00f9b61d216969c8789c410b..f75c3d13882d67f7e63f501dfaf33b54fd1890f0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fedfb496f9637d812237b6d76b0ff4f78b69c1ef..c70baa0e9dea870c051fbb7782ca0d5259104e98 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f390f865edef98c7c7b2ab0eb8427e498d1bf431..1d742629857729289e3c12cfd0e34d1f256b729f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa4605b4f7240b936b8e2a0a7d33aa6b22165ed4..7bf471d2251816f6f02a931613793598f755f69d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 393b2855672bcba46796d1993c7fd758a33ccb18..a3b8ac83f08d96329fe5915672f7669fdbb91f48 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1cdf57dac32119419b692c070de19386d901166..ee52e7267334bd454b35c8b5bdc4843106dda8e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 677f3dc2d4ab768ff13a3c1d9c869a28f4553dbf..ea429bc795bd5f373e65fbcc8b01abda78160ec2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79c41589886963b4b5363e74ddd0c1b3b23bcc19..30dafb474926b4d83657283f6c73bb823680c51a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b738b570a80d7cfd936db0719362dd634de76a8..c349a6dc3bb047e6f24132b9be3a98be795a4985 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9779644d56143430ed0193ccee0849b44e19f37a..ddda03fce6a29f6ed267d6e253787879a5e20be9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05defa7a890efa83f4e8e735be3ff2b7c00a1483..a9e3ad407bc8f635c0bf43c8d3a7022c0b75ac94 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e99308549bbf6183edac204cdd1c33d89e9fc353..e64a12ff47b8b265e88fb2bc3e2b904deb203fe4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0c2c2484291e77171b1ce605350117d719bc1807..0d652f994ec5fc62dffbee4b529f68232bb18006 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2ab86737b467f6090d6311664fd17254c7346c6..f3ae3c65171c2ea6ee0d02ee5e2ebc071bc50356 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a12ed057ebbd743dfda8f39fb0a8d6de32956071..42211e13d31e3ab780e69f266e756f3aeb877025 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 001011b636b0abd94a88ddf9be0decf997f84247..7c1e6f2b851c3a1b53e71cd2aa3dcef39ce322f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fc8fd974502ab2589f14eb4a0d01591b9a50b61a..56fbd671f65f8fe72b5a4d14990381b8b1dea9c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4798ee406f7978bda3dfe44c6e13325a909d69a9..9a82e4bf85c10bb47048e06b3710ee5e0f4bb171 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 192a6003cc12cb54865e33e6dcaa213614fa470a..60704ac1e8d9c4d7efc956af648fb7858bfa4760 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 308df3d76833a10c29f45530851ceb981796b03e..e1eb964861adb4b65c3893d9a996845724f60bc6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb74649a69bd63c8332b5efbb5762a70f2243156..5a833672bf1b7ddc4e04a4b20432201513d9a8c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d0c08e4cc6a02d32cfe0bd99f3b3312d06a4c7e..28dda7e558ded4866fa074b6ca036d6b9837104d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2f03a4ccd34f850a2a271d3e74ece891028d387..82a6d31b2d64c59bb471238a2902e6e916f91b96 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index abe338a374c5cef27da78e2445bf283d56ef81a7..b3246df6b4280a1fb864cdd00616247817c71008 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9022419abf5996c92b4aa4587c1047f3c0f8afa7..90d5941f135068ad93a8a52e4e31923a10b0cbd6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0d36191a0a700a923187c008cf445549e97f210..e0b05ea909e128b45364e9038f7d182b9dd585d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6d731a5ea578219774ad35eda03082b2703e7a1..0adbed262b77ebd8b7425fbef8c2d5bf9699afe4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2fecfc6576ba08bf97ef9b283a0d9e201df6cf57..83f3f6f79b207a6042eeab7386ae48a48827041c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9314bed8bbd5c9da8454527dd6425a8997daa884..4effe470ddb460c69b001b62676cc70cfb003f36 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be69de118803d9e55a0add649af64f5c9418e640..318f7fda695232d0dc66a56f95c19b3d7d0e8050 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 36405b11040d93d3980c0517bad220d854823645..c4327035329903fdc0fedbcda52b64559d32ef98 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ffa0ce3bb612d23255c94b726ae2f4ea350abf8..e6fd42f3e2a813f627bd274a212affd2a44cdfda 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f7dc59fd3f7b4624bd57c52ce7019ed7e30885c3..d6f576827e86358cec98e597c5a688a035a10d2d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 670c8cf968fc26ab1b6abc1a494309a5c6e28aa3..0d535815d90b090ac2dc7c3d1464cb13fe319bc0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88d885e80373c7bfdae9c3e68f625631e77976af..242ed32e12e47b7aca50b72de03c527c94f3976d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b8954669286a399abf45859cc773d0ac1111946..1f2bde6650ac310858c7cbb18901ffaefae8f9bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ba95677dfdb3eeeadb5938a0e56421f7c1b0f40..30975ebcc45866fcf66be46263bca8896743090a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82cb5608f8228838ec9dd18b61562a47c18db77e..3d393db88f3af74b8d68d0a3c2d84f472fa41b39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da89e72ed6983ca93c7aa8b768e0d13ee0ab77c3..749e26b3e0cdf67f581603f33ffe95b90fc091db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 452b2e305e41d3dca119876f12b4f08f8701147d..3a5055d5b700158220621c4190f779af3f7143b1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 894106fbbd39d25797390aaca83c8f31ccc6720f..01f54d0fa01e4ad7437bfb81723a238291beb1a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cafc2eb42c95a5bc085262b86097a51aa57fc7af..3c8353d1f85f481cea14bd598f16e7be26bb5e93 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22bc198da44b1bef0deac755e76717b0891d4d17..6a6306f5c37d0be5fe1acdfa2cd8f77ca0b0677e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4884dacf0e7e795ac1115bc8d5ae57e15707f283..b32b67f65e25080ff37e298fe30ef0444ef70bf0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5795e0cea5286b1591b5d9296d29c9d8b93aea6e..f736ef1d56edbd6a9c297ad0939f072794aaec59 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66175dcdf143748beb6a866ad6fed80b1309de82..bc576763e3ce81c5a5810378c09269aff0f8357b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e5f96fbd63e7049a030b7ded2fa232b47b6209d..b22071295510c1a47b6636a59d463da57d60af4f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd07e9cc8977383f9139bb90ab477d9b22a44f38..42989b2ffa2bddc4caa01256da05d78de368cb7c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c216120233cc64999026adb9baee02e6e2964034..e89dfb2876f2383006f767b08a4e27b8bcf972bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index afe58d8df583506769290ef6c3756749e9067433..4d6d30d7526f998f50e387eea9d00bcca245473d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6291feadf33d07920ad2eff2a1f3d49c5043822d..2f5d4d879e2c86f46eda9378adda5ae480ad9406 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6046774a49ce7e05f0cd09c9e654ff4a05aeb3a9..ac2d31907f5f8faf89b3840b6b7b8ca177333755 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 086bca2a5def9e8f5fa7067261cd3485bbb59ec4..b3dfe34f0ccdc2f0eca2349897ff060c2149a5d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91020359e92469633cf4793d1fdca92646cab327..eb085aba18f65cbfc65289dddf4ac97c57f2d613 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c12adab4884410d7b22c76ddbbf2ca03394ec9e..12e8ec5fcf6a2306a8c84a68b7496d1f7eab511a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f0a27ba4b706bc0f9b611625c010289bcb958bc..2fbc30adb0c496dc336c024fc26d1f3287fbf5d3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 51ade2790494d94489851fc0f57a13846eea4eef..9952802c8fd13438e03cc16e97e535d9d665dd0a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87689482d41c41e4f6871ca1349d711cb6b9d3c3..c2d8fe25a3b74f06b4dd398eb5de8a313456f666 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be304a9d32566e2a9962767f88a30c02a60d6bdb..62146a25ec9fcf3848422dc49a5ed7601a0fd881 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 199913eee1cc97314c368ffd092da5f42d4ed14e..e67fab0c98fd06b5b386f268c42705c6cba5714a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5772d322d56d72452468255a05101e8c85a2101..02bce6f712eb2153ae6aa50642520bda543ba270 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c02c8d89b1dc0faaa4cdf080b8a749309318d558..b887510ff91d139bb56e597c5e8b214d5fb6df92 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 19a60916b882f143b54c982135fe1b29d6cc0ab4..a8b037c75d98d24f1e84246249ab7d6477ecc886 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3409b4df33c2b4f4ceef07ac575e344393337c04..3e0227678177a9b9a9b2a96f29dfd287b09c3822 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd172449d3ec3f13f042e60186aefe450d25246e..12337b74b5a5f0e7403a506fcd07416ea887c5a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 015611a5dad2a4660906fd9cf0bda4d949b8e7f4..b10a7f55c1389e1314b7818e23b435e704ab1d73 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da661541235467daf238cfd24f714abea84de44b..92737f42b3712c8ee51024e41b923c7a957362f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a58aacdbce49d2ac66b2b4d13e116932c1a39df3..fa109621895f18ac10db737c864865163662647d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0d5a30fe6dee8ba0444beecb3621fef2d314d65..327e37263af1d389cac839c6e94a94dad7709b18 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index daf2f6ea9cd252c3e07fe779e16f456f424dab22..8602cca402219cce35ee4e8824f2d014a74b7874 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f2d72c30a2710cba92c596a7e56783d728eb397..c25db1fd32c950aad2dbb162e1ce84c16e8645f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35f4ce4406f8fcd72ae4ddc6e1eff4f855c1f8ee..be1b0bb92716a911951eeec9d80343e4bd62be23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 20fecda398310289d37b02df5981d87bff3d3b5a..6080708220010f894993ea6bb21601ee6c2cbe5e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b03d7865c0b2d08f7c38826d3f06b7c70ebddae..c9fa146072eebc03042141df3790e6ee70e99b2a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d05a8d296b320547c84f2503ff7c560a04afcab..bb470816e2fa7efed7a7bd613ad9c58f246bd0ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54ec54e9f4f855833df6be07d6bb162dbff29f06..bba90ef53fa203ffffbf53d69b39c4d8ed9e747b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f802513c19df126e85ee2e449f25da588ccd6114..4a65560121b9bfaf5c868e9229e34215b0e155ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0844ed178c3d933d8c5db977809972c57f5af27b..00dfd16a40e2d20d037fe0ed7db18f9abeff855a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52bb819df1bc8cfcde6d4469585858d499994f43..a8cfe02477be26094ca8cee2b81664bd79bd41a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28209bd5e87295c95a70515ef3b59ab6b74cad31..31613625b9f76c2c9a4f587d44d254732ca60a5d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12bee6046855b63051d203126b8ddfb7f3e42c20..850905c9d11d4480e415d6c2345691a1e73d7cb8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32ad9a810675cd372d701cf30913679674d9ac3b..a622d3c7608864feb3803a906c307bf562db5db6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf4bbb44ffb8aba891b622d865d92634e1019bb5..20011f81dfe016589ba8a216f7078a240b0ea124 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4f17d473ddf47de893f112334af571fb953738a..cf1320f03efcb6046bac38b6b0d46dbd8b99cd2c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4f9323d533ae4094402aa69c388ecacc4f78b69..074502ea8701d7515315ad50079192a97350185b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a3989fe29425944053d7ca5d5c0577970ef23e6..b4b6334f0d007159b2e28ae30b4cbb2786771b5f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a77f421ea2eb46605bc59e52efdf99f9844fe44d..d49535107e69bf51a4fe2aa26fe526512812f09b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e916265626f6af2b318e1eb875ed06e663794cb4..db1f79e599f69e1a9d22beeca6a3ee018d00cbca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c77b321ec4d351d5fb9efd8329672e5304170efe..4df84ffb0facfbdf05e969c498cf0dda9b94efbf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4852b1eebf88c66462f90008f98f577f7e273b0c..c6a66cf2a2a4e7c9e26b93cbb3178edba76ccf8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d72c690f732113435c21fd5f301f1c1f01a7783..3b6cd092f8e1b34acc7fa2055b9e1c7d97bd517f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee69dd1ac90c78626e32496e8d12e33ec3522709..3e31e3cdd46152467d66933bd5541f7177adc208 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a75397d2625c41a669948712ff5cf16abba8a8b6..17ca069a1234b7f3c6a9ca3307f131c512c69f9e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 904bbfbc378a0e2d301a476ab43c845166aa0b86..008f9716eeb1ef241dfe5a250a8b5b4760492381 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a7b81bde1d5462b720556c0fb94e5ea38951d21e..912539c95f7fa5dde802c01485723c02d8009521 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 610374e8179d092a62c771965c69356651ab72b9..3c416f9bca1551558b89661a7037daf4ca8e0f62 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf2a7d18febe23788742943894645e36c5e4a11d..04479104c058adc135e783f98c12f10f5f4eff63 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc482a8023ff80b5e9ba6a754740f121843507dd..7dea01a2dd15a83e72bcaaa9a9b0549d34a49546 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0741a3dafbd5dd75b60fc10a071dd300aa89334..9ec0ed2bfc60ab502cb467400416af2c6ce5a3f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b312adde3ca4e2511d56bae2852ce5b071ac9869..3a1e379ea7ab7c324e5e54e651d5f18607796945 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c66a8fc3f1e01fbd54adaacc4a6684b94ca26180..7f6b61c87c803244f2b0b416308a8d0daccc9740 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fcf96da3293256a9a1f70167e3380fea44820b76..5004482dc61e66125ca304fa5d2fda454668b927 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e8db0f684ae3fc81b1446ce70023193addb5174..46806088af35cd72a3dcc7656900a0e817e9668b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2663f20c4e71ff8dc7f9bb860cea0a1add0512b8..32066e984bf1fe71c42493dc769ecd92268fe46d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df5542feed711c750e59d41624c8c74c33d43afe..24296483e3852c0b6002a07c7b35c9b6e9d52f38 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3d192d9c46e8c39ad0fc6fca467a4ae7266a6f0..bb10796d1de8369863779cdec32c4d1d467e04ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ffbf36958e5ffe31d4f503f497735a6883c4dc6f..3ddf24922ce813e06a5c1a507d52864aa5d7b5db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e94d122d17b04ce1115f8c1fd5123a87f10bcdd5..00aa9a5a6d2d1e22f4c9b4a3c55699934e68f564 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45c215d169c5f11a11d18faf92729f6c3f3c4ccf..7af0c50429b5c959187f507f16b68789ac07d715 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a49f1bacf84f7065eb0c3df054af50bd9e6d70e..3c85c41f2e25f873351216a9db5048f19bedf06c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f53cde9d30d262a7452b2f6bfd8bcd99d064fd30..9aa0107ff1bd2eea53a46bf10eb54be9d99abb43 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ab37e5f0228784bbae2d5c8cc6e3b02f45af840..6f0a934fd2f4fd54ae85f09ded1ea170ed521e9f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97e5f6e8b4d978bbb4af134b799ea33eddb6da00..57add196e53b4c45414834ead242997826275a96 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd1eb62d010992baf0b4958257ce04752ce3987b..02774edb91e9972eb688b680962e406a0b8f5962 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb800615d1cd564644de801788e758ea4189c4ed..3db0db43e7e0abb76d75bc9f19abd8be3c613ee8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d0f58d69045f86659a2df7931a3c391c9c8d969..e7b24aea08c2efe68dfd4519ca6c026f1471751e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7e6d3eaf7f20383d3bba2a1370f585acc7d9fd0..cc20d17838de89f8a636946db23ba35300687de6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d8f25f2d9c7f8b951a033982cfad1e433a6f19ac..bbd9468257e8b1498d1a80ceae1791f3a0827be0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ca95d91c1849a3275b5794ad0fa4c783825b4a8..a51bc5396b95b9368457e022694234c365721929 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6236dcbe17cfe9cbc59b8fed3e07a08e57c275fb..3e39d0bda8a9f9d732430aa46788850ba3c25d9a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d6608d89519a770c8d80c0e6515f2474b2340b6..3717f69894b6a5c380ece2574353db84a246ede6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23f1351af712c17c6fe7a4df2365fd77bf99db77..8dc121b5dfadd28197d34b7c0fdbdf7acec3091e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab7384a803089f3fc87d4b7f2add8ebaf2072c74..fbd5c7158d331d089555259dcf9a554b88c7e96d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97465e53a5e148d75ac080a6ae0292dac77c8b4f..ffd8e2705e274811cb18ce1dbbccd0580273d0e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c1d91314e4f0ce696379fd864a989ed050838e5..801e200c9d7e3b299a169e2cf693b5b9049e315b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca1b046354e358f85213757198dcf0bbbde97140..183ac2d444d9b1d21f37cfeab35a095fb9e1c126 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b57e3c49f1b5f60d25b443ea3bdbf099ae60d509..6a8de71963c1189da912eaaff232382841a8e9b3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0baac587f614a5564abbbd74880ebe6d1c7f2f89..26f734920e9541851ae901d42fe02df33756ccb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e61c0785288e9284ec6ab4566c1544c41441a65..c26e14911a924a309fed605b290c8a4fab9157ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d15dd7506b3b4e08571d44e8ee200d061f15ade..75932591b07541371cb1c87a8823ee5e7d3d44bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec942dd3a846c271c148f419764910448c349e2d..04f7fa9b0a414645554fd0ce2f59565eca33f631 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03bed450c39d5f391cbc71de1e9c3e9d1d9be5db..96775d9acf5f348571f2815e457bc9d3123e7ff4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0542cf0a35e7b2064cbc18f178ee08939f31c53f..3dc3dcf904755be7b935dd5e445ea7913f74af6f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7a2227fed8ddb840f2f5edf99b72ab0eef33b555..249d4c1691d6260ff4c1aae82dfdbc1cf69e4df8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index feb6d33154a06a51cf95d22cb21feb0432d86fb2..a4dc8a814b3eb1aa3b7fa84dcd2625bd53ecbd90 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 114bf809b268b9cb3168d7393b94aca78b5ecfd5..ef7fc85f201dfc50fab60f092f8cf39f7957f419 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0409604b1aa3b764caabb3040970c47762fa914..f1b8e2a2994ef71d97524c135a0ef4cbd81f360f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40937b7b6ce29b14f2b11570034ee53f80fc6976..e6186debf68e29d659ad9bf651c7d43574d16ba8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f5df444e92701dad130875f0aaada63b5eb3c81..06335095a63018119a9a5976beae519b0a20b567 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 796a2d1cf8bb0c635404364f1c8fd5c5985422ab..30c067f4f8e219ef7cb9027935d113635c76922a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b73dee3bff03200cdef731d422f25ca187920dd1..398e8601351177c74f884b48ccd36753710315f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5095d2f0fdb21b16d4dab6f1d221ee768932de1..1a4bb2c713c7d2d3e3340c0cb24cac59668a3bdd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc166b3cf60949a7666defadafe4392ba33431fe..300c2070734a1207f123ffe59e54b2971b712b2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14c128f3045432c174d32ff1d4506bc9d30d14e5..5ac5d931740df7789d3014564b8e89279122c9e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb468e0ad60e47e0acd6a3af48a898a637217145..f8963895543ff90e0889ee2526fbc0f58cd1740c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 851807ada15dc2aa5eca226618edccc94f802ad5..bde0d89cc5be4d0ea38ae9a33620bcea159ba81a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 802f916e5929eb7bd13da3d216c7d4b1792d32c1..0b7f7e2edde6405bd56463e7238b42061be0d0b0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99b0da1abcae715c6e64c5a9df544223709a2d55..a83aa5ee74b7f0c1075d362e19ff0c1580b4b0e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8113bc411f4a843c791be86416db5ca584589c16..118e2e3b7ea9f2d65752d31536545de09804a6e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6821f164414935930658a3264dc50f4ce707ac7..f9b3c992c5ca13fcdadec50336934d6a535f8bb3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e0d2d1bb7c98425cac13d4f9f0793891ec58624..d0ae2ca1319142df5c3b115f2f1b61b288171bfa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d0377088a150f56a1152f3ea85fc36621b30e99..ff7af116a15fc8582785f083f3e78b289ce9f4fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6481debb3902c2041ce77af8d725ca5cf4d3c06..60634005e1a1520d492fde84db8f80b1e48c29a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed427db14ab1900908d8002daa738ee310d6ad78..4ebc44a532154bbbaa2c06425675e60a8fb1abeb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c30fb59b4b3a213894e6e61d552c4a146b292a9e..6bf10893f20603ee913a481dd0a9e002b8852d42 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 594704babb90e4a5def7761e38219a4f4189bc11..6d069e219cb8f5f3da61d7f6a2165bdb72474cc9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c1891a659fd2bc0c34f68e43c45aaf3dda77894..ad7bf809a934d2cf88fd69e73dd3ef414be6c3a1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff2e47e627eebe6a395d2e2e603bb78d05284cd2..d1a432dd4dcecadcc5edce6fe8435b5bdf0d8cdb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 332559f1891cea4bba9eb443c130762b2164abf2..bf60a800c357a24ed0df106865b7bf1a95d259e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 20b6541b656cfaa4da5bfad6da74a186a9b853d1..7f9e56e3536904be55d535623fbebaea4add1cc2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index baec9fdb4e0d79f27b97c97d9926e04d55a74d4c..0033fc0d7ae0f2dd792ba9e3126412e880dd9a86 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6cf1ab0bd684e8effff015b25da94be69d51fea1..d9c12d35164c4a6e229c502d3b177eb445889cc0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b7d3d9cdf9c3f361902abaa3d95c096f21ad395..76a48edf1f2505d19868f6c8cb2e6ae0cd494b2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ce72fc9168730ff4f874ad26d14211bdfa7a510..e63b657e48d82f70606005e365531979cebebc6c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e43f304ef7a28864c11cfcd76c0a6ffb24e07931..69212370ccc3f406e90878d51742d7f9c0fdcf3a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8d4e83750de6dfbc8e9afd96fc4cb64b2d23b1c..10b9962a8e90e09c0d1d861b50bfded1902716e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b460124c117138a769100f59dd17da0647f07cdc..46dfbb3d4655f36df30b2753c1641a9656871d09 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5d046069059823cb27acc3242e79e118f5bd2b77..1dcc9ce61baeb2095a1372f817a2c4979577975a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d74000f4ce305f9dcaedcd40aa0845f0de7d7ee8..e53a527341b1229974063ed5f6ed0047e2396346 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad1d613f8ffb170b926ba6398f0ab76b1197f2c8..adf9d367463f411425019e8bc363b12f00903f1d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c4731123e4e0a35d6709a6d562b34332218b71d..74688de4756c11ed26a9c3317e190936f61f4d3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 310578022d217e03b5b9c1899abdbcf72c69633d..6aa24dfc57c0cc5a2ce36fa35ef6657aa70043ba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c81546f3344b50bd467131a36fc538789074813f..64aef02530142114f7c81bc6d6a7abfef8b42dff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f3c23919e3d690767564c1e3573f3568fd842e77..58cba825df403b4fc8e6ef26017923aa0b14585c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21f2cfdd53aa4bf3f157b1c5add66194020712e2..0f52e7b8566c8a9f0e59f983a61be9d4fa0839f1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66cd4e22f2e69dd677e65744af4b1f36139ad256..9d387ea8348ed03b254db6dc2880f860cefab792 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 304884389ab0df1ebc9208ec6f6829b61c72662d..7df5f12f06f4cc15145d7d474dc4e538bfa868db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6a91a721402be850adb9926d9208c2bb571d247..b14180de7e7ae2a6dd87a62c6ab49bdbe9e7c0b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019-2019 by the deal.II authors
+// Copyright (C) 2018 - 2020-2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5513b0a8212c99904b9d39e1dfbe0ac9d065bd36..55d79dc461a67fd11a687c74ee7ca7d4adae58cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 091563cad031c568ee1768818a37469e302bab14..7b6d0e345ad134a3484bb8a9f8711e7cca362a93 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a4e71678dd867cfae3e517162d491d3fc98c16f..ea114a0610020cfdff9c9d6b922578c5b95dc24d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70d09c79be1cffeea85015ec4860e9913e0c3545..4661b57706042211307f94c5666e36717bcfeb49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ac94c384a48bdb9564bcf3b6b4c1432638d5596e..4c637cf50731ce0ac6f5cb4c0b9767a6d5a1f6b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b8fd0007919e6d91f7cfc2dce15e5536b0bad7b..6f615f701f1c1e917f81a0385393339464b978be 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c90a4b4184b1b13d4b0b4de77dccd68c8ec50b9b..23fa3442d18dbe0b7e80387ea798544f5f250505 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b0fcec35b76fd98623befbd119b6b0c93670c64b..6e7884cb86df1cb93d8c0f590dd3cd33d603e1b2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99018c7b744a7e158efb6b4b41bd3230ffb26cf6..531d66ae9ee4fec2a2e7a64ab43aa2ab90ce88b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e13377d01d6697f83c0f137e2fdf2f5c0c280524..f0dc3f2cd3bb8e9e2da18d04dafcea3b758ad938 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f386195cc2c97a86605ab5620e4753b8e611288a..61231fc99c28eeec1f381e1227a95f79d1ca6dff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019-2018 by the deal.II authors
+// Copyright (C) 2017 - 2020-2018 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c7ccdc9a3168904e81e8096dd75f6c7b43c4d6ff..bd852d897097d06a9b4fc610978d69f8c7055d7a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019-2018 by the deal.II authors
+// Copyright (C) 2017 - 2020-2018 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5497d3a902f94b275ab6ecbf99a0ad9750411271..33474f3ecbae35ff3f3bcebaacd2187a3905e80c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1f9908c6daefa4eced7fbdd8cdbcf4bf65289de..3b946c189ddfdf08b5571815c347fe7d54ff273e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b73b804da97f78b1511b9b9eb0e0e2ecee52a77..3c171519cbc007f3b423fef6d77472aa659c8d68 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b257dd5d1e06c06102f793c73cf40d803a7e0a9d..4f89182fea5368ac13989dd9cf538b720b416ef1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98c88d14f52ca79ccbe8dc4d772fd9ba7da86640..88de4b6509f28cb7a2f623e9d89eccf5e82a9993 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a1266795d4e570e49872278307fe3ea2532c9450..e9040899c4203ba5831f1df040ce3dac62684ab5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1beea73384ebb696826f69068a61e666b0958349..007f183c3a5f736ac10c390e66e6ef449b1ddc49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16228383d9370ed175e99cfb5acd8a5886d7756b..1603abbabc316f62332338f72d6680211ed396fd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3360c61b299b06fb0c606141c37dd06a8fb183d9..1adee126a6beb6856278e8a2d90a5799093ed157 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6d06e2bbf93a9620eb2216320afc7f03865f542..902f03b51b4067b829258aa3ac596bfb3288b8ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 458a54cab65a790f49809b76a141b413dcfa546e..e57b25cf3154efd8a7735778b20df08926ab1b0c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f04091637b731e3e7ffac135d91c3369d8321ac..128209273b971ef2f1d83a3b5a59549d2892b0e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4668359195d9080a084fe046f6f709da5f19ee37..bc84fcd3cbdb3db75aaa1c5ff24d4b5569443fb9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 351697570e3a734219101f28ca6638cfd4e22ed7..85f119ca453a1fd1e54cd1fb9d9accd34720c4cf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6cf0f3a1f59111e33c6ce89b02b90d80291b3f3..be5ddd4065b35f4730f22212b6b2df03de27ab0f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0bdb91858805ba7e49da5627ff5ae10fd0a24251..cc665493a7c6a646aaab94ac394f47ede1befe7c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd72673c704b6eb560d27d4a5162f1da80760d89..e79273173f0e7aa33f05de1f259e3b15d9f6cfa0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b9930828bbab66f0780345767c21b03be066781..f572d1c0d9cc48362bbf08ba0fa2f3633a796885 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fab689d9dfcd7e81a38bf46854b1d13c6f27922f..0ca85a5f0d282ff57c744d74337d208d363b0688 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf804dc6cadbebe9e42925745c21633b42d9fa02..61a6c9d8888635a00ebddf3b1b35aa6fc43f0aa4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b7bbdbe7e327f3379b2685962c0acb0b8dc2349c..17ce245e1a051ee857f7f968630e32bd0d071e0e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84204ca96233762018c3e274470c0832e441167a..5cd81e93037ee24a591b3a427febce9075284cf5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f4a78fc27c180041add16df9d2e2bf9eaba88e2..d7ab0b4dea93f67ba8ad6f8473a4ae2b31da9d84 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f8a689cdce6ee23334e28d08b6562e8ad01e32c..e371c9c7e595a7b849dabf8ee18d8e7d8bc973c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11724c5cd1f42870518be17ae517395a01aa4466..bbe081e9af2302215a826b9880bc72347262d0e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 330eaa9985d8c560c33981df863d1e9d2fc8b56a..c119fb1caadfeaef75e7669b500135f4c1319945 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a14c476f08aeab5477568a03e73eac3d8974aef0..e4437405e7ac583bbdbd501bd1fffc53249c75f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4286ab76da1fb2f7187cc858a1c808e75f17f6e..e5f199bca51db7afa967ef888c3cd5f8cac55d80 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99e9640a767888a3c7974f4f75570462a95a45c2..645f2db5d5f59ec8b794ca4f8f55266b292e5c62 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5acaf5ab1d75a2bced3bdb029dde4594bf709bec..5d2e8aeb223f2ae70d5c771ee630d22770d95642 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f3883c014fbb0eeb0f7fdf9a99c4a6d660ea10b0..16b480df0a65196aa5acc91e85ff94adc0e83ceb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba8d90fac69c3fb44871bfa8b39617593b114784..7bc72592a3a787d7687c59f6708443ba27ed67b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2019 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5f249ae113a8e4bacf0a216ab863f027603361c9..d8072218be0b843d8c119f98027e6022f86066f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2019 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97947943136f315c8c611a64ab2665e39dc07bad..aa49e986aa092370fd8f7b6dd74cd2a27cbf9152 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 26faccff40a2364dbe5b526198aa07124ebc5997..c12b057271256ab27ff2adaee63584e11be194a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 09f7ff3d61dcd02b279f6b79ac392f0f3a1514f7..2572c9a36a79b7e8db6202f563072ab92d0de516 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ab21ac7e3c0e77324c22f697b54924e1a18a4f0..f98eaa571d66d2855fc0a5a2269a88d2f6e71d11 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c9944eba6cc0d67f213767226c5bcb2bdc749da..57204afa0f822e668ab1627a06e90dec518a4443 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4416046fc3cd6b777e92011bbec23019c022175d..19456e863b44b0a115c612fc324fc1ebe044daab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9fa0844a74071f4983cd703ced6cea79b7cfbad..9986a93e6847d8f9c61dcc6900ba95e66640567f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95941a31a7dcb351c7ab7c1ad93ed9c80a0d999b..f6258931f5cee84299861ddb12cf7a7b3fe3af3a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 36663670ff02e052def6709fd05017f84ee6515d..b7d4d961652d6ef825aec8b8ada4684c302672b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b70244e654c843a332d2f8840de287b1e17033a6..7434b8be7948b13c21211cc9102058b7ca78a81f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 536b657ac663445151d8be2a465eb0621a0b3f01..e924a4f02afa0bb23245ed247e6d6984bc5b6235 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ab0a36e1d9cbdd9b1eb3a5eb4f867da9f02548a..d245830c73b1c915ded9b4e8abe88a8c30651e86 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2452c22508fbdeec0fefbe6091a9bfa093fd5e4..9ccb26111530da152b9b28eb3e972d9d46a55fd2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5790c5e5adb968f2f110221199f624c52eb61e3..5822658c05014cdd97f97f25ade18b6cfa5f7206 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 29e1627c7130b9b5c18836ba1a33e071556d86dc..7de31a4518df93d96df24fa9d34995b98434140e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60eadd67d7899b455f6b77e9a73dae0afe508dfb..972b1a9835687d389f1d7239aca5fdb4be7dae01 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6d2c02056272d658272ae9820d958f56e7e3c2e..46740b47ee2110f31da898038673dd935a5a8bbe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10b5df3b8526735a2c8a42392d30c461161fada9..7a1b025934d08d0eb67a3a4034d281205cc865d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5f3928518c68d2768336b8ae91182df93de358bb..f75d4c387f2ba3f67464d2d714901c851e7dd589 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c7b9eda6b7ae9089f59a454aca8a81f2835d222..9ed85b64f4bc7ea5c6f812c629d68c86b7ddb369 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd316ee430cff7e8a6f7b1e869b71c36ff4f2a1a..97dcf21ff7e0118b1812c7c7412f35347091ed28 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fed4fcddd55500b431b7aba5120d7379705f39c5..b2860a91f7341abb6d8ced89ff41697e5cb3cca8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 652c4573122bccb952b741c13adef96da88d7907..d0a27e48ee1ebb0e3b362b0e9f4cdbd7dcdd24c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce2d7c7cf15625c96b80cb4c338cc03be2af10a7..40321dc9cc4a9ea6bc2ebaf1132b2a4471169e84 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8128855ea634025e4f7393950691e10f30f98db..3cd3707cd77759d467a0c85097256cb5f13cae14 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 796c6d88dca42e8080fa22bebf0013a4e23b4e1a..d297173a343c65729b68dd7ec4620efee9ac68e6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d62f0dbdc13e3e506a1580c967dbbed43a20c0a..f133bfa48836d107643f713c354f2c19e9206df9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2019 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf65a0861b085f0955dcaeacb795bb58562b7d77..24721747153fd810574b37a500736cb1e82b3aa8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ec9f10f071bd8ee7545cf45469a7e6409c28858..1d78f2275b25985b2302406a6dca6e791cbf4550 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 678fab5ee5a02dbf087d61ae73254386b0f1e8b2..93c0f6841a6d673005a663a61297b8279d25256a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0353500ebce6259bf4211bcac9703fbaa89014af..2869656f70edd7248d14a244ec209df64a9c3527 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21912c3fab494f5ce9299ddd4644d6b442030efd..13a2f9c8483d446007606fd5785dbd7159abe2e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce507f0f226ff7c8cf4b53d6e0f1087baf146978..ff8a21028134d896b28de5009a280d819ac2a8ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 027c356365c57782d458b3d245a81d7154a194d3..d91f589f424afdf41e864ed85f3a4ce98552bd48 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 070d9e568fe32156846731c7264cce594c56e164..52ef04a5de82cacfa02b85c04ce5639d26d6fe18 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03974b895f1cad52ea4aeca357c1abac2a5a720d..d2a92e1b3ffc6ba3f154df77ddf52f32f3a4ad64 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22a830b898c2c59963ef30b4d8486d2458167f50..61f67f6b2990704defe03b6ab6d2a2ff8cc4366a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5aca52f0419dbd5dc0986171e8018b2e20ed007..ce848bee07373ab797aeca9260d8c7d33a71813b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8e2e1b531aed25f92d58036c00f9669846336a7f..ef7fe74614fc392001da507f611926039d31febe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9606fd94b4ad02db9a9aae10d412352046e0924..46e8f987cf656d534548982b4650a4b2f05bc3db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1fdf109f0507def9c98c931576cf357cd0916090..4d9a8b63dec39619e2bbec57dffccb83427857b0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86cc67be9e6964ec53baa571d67fda882fa49221..e354fde6ea6c9aed79d2d34528f5b3d20832e5f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37bdc575b347f5e9488453a228dcbb67a8911ac9..e3a0b192ba43091984e6d0e45fa5d2bb3e48730f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a9675e261a537ee31dff0ee4409edfb9e37f51b..b594dab630419d0cdceea616c76484ae9267ac6d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71104dd73a0ae377ff83c14956bc10ddc2062d14..95ff1a1113e111ae26554cc168f7c80801f2694d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b49a301b4da6e43adb6c4b6fb57f29dda0d85bf0..41b8f317fd37ae961757b8ffc4c99cd2e2e6f559 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ffcdf269415136def0ccc45fa21d74bd8c05dd7..a03ab29da662a3a90275a880382cb94eb183a2dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e7277c02e10f779e98f48e9f2d53658ac964408..5ca954a4f8572a285cd03592e285c5a4892d1792 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 118c6362c76566cd860532ed2cf4d9fd91ad9cd0..ad5d4ae6f57bf8451c3bf21c2e61c7ce0be7944f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48797f80bbbb572494f68f2530975773effaee5a..be2d46a07d51e78bcd1513966183c73a9ad8883f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af4afaf5cf44331f81addfd5af1bb1c5d7e458de..99b5e58d466e25ac7ee36c88bef30cbb5c87aa15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e135e4f5e4c805935e1119d45f1baba37abf8fa4..bb870c5c0b9d36719f915a831bb358cb4c3d339d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5b13017df3a1047baa5619c13bac49519a034e4..6a52e66659aa5d6899ca5ff909230cccca25916f 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index e5dd43b017009cb092d2b1893fe41320e53b790f..b299b6f36ce8f00458d36a4af828e9790e49e46d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f156cb75608315c8c957beecb127747664996c1..c504d35ed18aa6fa66a2ac07c7b86277a851af60 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b373f3a6f318275c66e637bd3da61191e5033df6..1b1dee2b085ac46d8e7768e2d9bb623cf6b1cd45 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 818d88e1cfc349d55a91f80600a32e5d796b82e1..659ff74187161a4f791b1085ad9951ae5957a152 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd125eaadc351e5044e2918ede77c80d8b7ade0f..15902f76b61e4a6b8faabe322e3e66e2237a419e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e45e4c7ee5f7dd03307a742d1cebdbea43417565..6d06fcae81167b7ee47ee2a3428df312733f4242 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b573979665bef7480e6432c437595ee71d0f3c42..d9d0c81306d62b8e60c058a3714ed1d96a1df47b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8267e94240b88eb00219939215e56d7686d56b73..bfcd2c259c91c1b0b1d0c533311c621547049d2d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0a79a00f61836e0ea64a6ed336d36268dc76fd0..46125c48a3ba9b550e23ae54886693cd66508914 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6be243919ba918da2f4c0ae9f564f2e40ff74d19..fd9a926352867f6987107a59112c670bdb993ece 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 62d873449b833bedc27a94e307ef1c436d4ed177..b7b64cecb6c4d8d8958ca905871e1bd7da9cd5d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9db7883984965a89475766bacc69b4ee799124a..9a80b53f59e70ac3cdbb3eb88e538d9d5408d279 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ef2fb13c13429272acd8bcb63b1d6bf00d7701c..16c41b3160d63f8fd87ca336cc189e1e681ddcde 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index edd22ce0f856e9d80e735cd4ebf0ac0c463243a0..8aae15d97f07da9de151e4333719dd46dad9865c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae2cb46658b9648e67f55e81e15b61ac55720ce4..35f75aead022efc3dbe33acd0952e9034557e64f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 756b0f75f2c579e70c4943efe02ce3058a85d169..c4f68a49513a1347c9a04982fdd994c03dac2944 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6262c79e4207aabb65dff49270a5eabf99de51e6..23dce0cc9f833005eba485627ace3caddad299b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b9443a6206f297d21d1e23962ec0949f0608145..604ff95d180c9ec305e49d22115712262c6637f0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e8f2808788613d7bf251a01a619ac71f28ca03d..6836b84f440af75b3e2b1d4085434e52375cdeea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd26c265537ee08870ab17bdb453713672d5d5c7..ebc3bf319f30b28c7a60323867998d920b8d39af 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4fd03a448545020ab590b9cdbea4e6708dc2081e..8038d56a8ec67c929072a8380fe223a02f5ba037 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ac48215af038ed5c560dc0db31f9af863754659b..a148f1cb81c95625b64b1924cae84e681e72783a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f977bb48af5c48abca5599eb935726179d1af350..b5253db807c76bd12536ffb3c95cde19dd197db9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 893b08cf1fdf40f43123a08585eab58f40aebddb..de7479299b3811be33800a5f9475082f809eedb7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 743ec7134da926fc09b3751137de2d77726c166a..23fc17db9ed867680b924efa02f476b98bd22333 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef31c36c9fe9207e415a4013e11052a2518fefb5..dca4cc17acb49b197f35ce81402ce88a2fa88536 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b9a0fd94e7fc17aebf9dfe9716f0523c57bd6d5..d7d1488a738094c29b9e0b529ecd04ee8eb0fc4c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2019 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c959a8272c60466bde5df6961c74c4406ec8a8a..95cbc7bbdeb1133da55f45a80681fbd5507c249e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b84652e2c23a0aa994b1888a7d6844d7125ce02a..ac2484053e1a8ee994b45260d565bb96a4776ddf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88a358da18267c7b783ca1c030e4e78208ed9849..b5a9f169d8a210b62b68b77aca8225a353ca1143 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e04bfd4caa1498e6c870e74e7586a94bbdd25851..a2fdffb4eff8a0aecd1265e1969281c2327be4ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e4d55235fa6fc18fc0b8f8e225acebe4e8ecb0b..c51fa8606cab2468a803d695711b0664b1e6c0e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 160d899b2bc319b06f8489fc42727325e7a12234..ffc501eca6a8224e18a1fcd61b49e5b94cc9fa8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf0051b5c1ab855481af8c8f05bac511b34a6323..1fbb20876fd8557b6d356dea33809db100082a69 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7cb8734cd73672e1e5b10370ebace4eab70dcbdc..9df6d73c7717e830ea87e6542f138e96e7a70bd2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13f6842eb89c29eaf7b31f7b093a97af89db2513..0a098393cc51c792449c163ed411ec6dcf36e53e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a3652599b9c96c32d56d3a59d2f04037cad25504..b985d92c1bfa5633a7df994cd52dd587913ac986 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0ef70d43130848046ef3ea83069faed9a472a8e..6b422e7c08ab04ca91f715a17d9a431cb094ae79 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18cfa7510343ab1334d4a28672a93c22f4955cb9..055dec3df1397cd3dec9b8105cc9ff63ad376a2b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c96faa66f9fbd8f8071162db4b34b0d2076a66fa..40bd30ca4753b5fa5eb83ddd37017f976069a2b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b905db7bc7778ade40e4427bef91d2f11008030..0485c29a85df98445cbbd48d8e1af32e51a30775 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88cc23357da44f13d692e00ffc5e5f520ac4fde2..fc270e33a75ae159de44f62fe65cfbd5a54fe6f4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0186afc3c3f5aba435990e28215ffd15a669a4c..a638f4ab006c95ae096ecc6db92d48771dda9503 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e81c7b6399913650bbb22fb40408a79834750e8..bd3f9fd38ab8eac54c64e7584c199c52d71758b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 836e79c09c9f0115e1db95973f42d11462d48c99..7c4ed10cb8d0a1b4f15e64cda651a8509ef8ad9a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2313728012684b22caf31836e2b9e6ea6ad8feb..7344eee34a014102c4a329b495b90db4595df05d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68b0519698488ce85ec61fa25f7bc6d80b14f1c8..b11e0ef214a590e45598821e9d9e454176a07cc4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c21f9a8bbd0a389baafa297de1549d672884224..77155798c8710c60b3d8b38dcf67e7d443ad29b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9973b5de40e5911266b8359185bdd55fb5e208f1..51ceec93547e2bc41043880e642dfda2e23587ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae9b3afa024d8166d88a9ffb2158343762a785e5..c11a2b5f6b90a51bad389939b425f2f60642173a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6fc979ce538f06483189566b79904d110fca2609..e9af6a58bb396ea35638b85bf1c31232aa902977 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 27f2f11f7f68b17a083ac1eef2b48c7256b844d2..ecc3f3459d1b4f5c974170325027eadeb06664d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1999 - 2018 by the deal.II authors
+// Copyright (C) 1999 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4ea1908543b67028a5cb8f4cce113c29993e3ae..13ab8a22e52cb4478a35272040fe16d9a563e0b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be585ced8dbe43e210441d80ae2e07948fc69de5..fbbf998e1b15a7355d5c96d463f068d9a4e1ac6a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c1d28fdc3a75025dbd8dd589fe901da4162cb8c7..937c68448cd6a83018b18a9f48ff2a6b95546dba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42ed330bb744770283b84bdd9e36dc102e9931d6..bf2ca53be59a5fed7d8c9dcb0732b314938479fb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60d2f855c71142eec4411ae0dc6b631b2e952291..e8272370cb0700654495c05666e4db4169ff2b79 100644 (file)
@@ -1,6 +1,6 @@
 ï»¿// ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 30a493e7df0275a926e74d167894ee63c0a5c4de..88f54440d82197c5012a4703f08e4f0ed8e25d24 100644 (file)
@@ -1,6 +1,6 @@
 ï»¿// ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 36683b9f73a7a9a6d2f4a33b80e7043e4cfaa22f..7732fe719e87cc3ea58edd074138fdc27b1371eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0419389b5df7030a87f24544b530b00023bf218a..735e01a84025b71877bdf56cdde7a507d8fae712 100644 (file)
@@ -1,6 +1,6 @@
 ï»¿// ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e2d08f6c5b42196bb1dcdf51c0855afb1d6826e..d2f4bfb56dd9fdbcb6f23da712a79f085c50fe06 100644 (file)
@@ -1,6 +1,6 @@
 ï»¿// ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0ef94f6102379cdc103235842aeba666f937605..551620e885f90a7c456265683d3e4996a58401a0 100644 (file)
@@ -1,6 +1,6 @@
 ï»¿// ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 06891b6bd01ebd9744349a1234cd4b800eacc773..3405727ca66a8e0a8e58c63ace0d11c079591bb1 100644 (file)
@@ -1,6 +1,6 @@
 ï»¿// ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb077889e76d6f148023fbca875d0249ea6383ff..957b817cee0e550eb89f805cc84f887e447b61bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4e749fdb5f504d87b3cb9a432e7b5508bcdac0e..d80b028f7e41c7d58fbbf5634fe2f67dbeab38c3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 51285b9d03b4640304d663a65f754d63f825af81..c81d3a307719eb581051fd2a2b3a15d3c9153fa5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af3533315349e82039e9123c085465a8149045ff..0762e62e022d296c876f9949d2ddb8fc02f21e51 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d2ccc874b4866ca9d59036c060ee2da75c26f744..cbb40276b580f4040467708278be901e188b11cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8b32ff2eb7b8e57ec9129646e8bc4b1d65a3d58..e76030b08d7beb70e09d67b6c1101d4702e0a37f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dabf279b999ff5980344322059a65513cecb3c50..509a96a905cc8652ee14669a59aed163f6125fdd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63cfa808f115f1257ad16962cb247af38e435df7..ba750dc00bf0da24ba8cc1ccce9e57f6169d0d05 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0fe25c66798a2170b48c45702ff587b562f94c29..eac9a011c9433f96bc45918535802837c8e19ccb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9fafdd526a1381c346e363c4de4bd77d7f18355..a70b448209128686d1bcddf36ce8f43662877752 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ca0b0bb697c08df1c4d5d1898089c41dd8d7ecb..2b480ed9fa8b1a04ade1d61f69cba258d872b744 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 333d652bb96e141c07942198205924aadf1a0141..12868da0d0ada650d7d2df5885f5d0f5c626d8b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4eae411666eee07e896e9427858f28142e683f2a..7be0fb1a171baf66e1950a01a03b121e86b4844a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 029f574d88cb19134a123d62387a3c845fd5bd27..928ef8d6a556331f96495c7596ed22d39ce3258c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3ea1fd389a6364204b39bb21409b3475419e257..38d7cd947f4bf283ed9fb5334a39f672603994b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d72c5868c751cca01393a6ce1b45f08fda97c9c0..5ef5da5f356d1f13ef150defb1d412fd5f23f1c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8683ea7ecd8dcbad1ca3b6e2b4e5bf4c40e1647a..e5ed3b18f9c3e7ee93ab5d424e36b15a96ba0a11 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9395f1c579dffc54997355e1a7c87d2b4f6de5be..b2bc00bc97d8d6c1a82b340dd3658e8d3dc7f0f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8aad743b4fbe56b60d27883fa53caadb242c7a34..69f0e6ba5e9b29e3a5646cf9c371ce1f17d66ada 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ac60518af673f5a11211fe6f3c47101ccc1af3c..56a28e25cfeaea6077a05f511a6c7154e6ef6ae2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f079075172550bce1add2b1ebed9773f9b3a82b..2356e185094873d7053ddfedbb9aa937eef690f0 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2006 - 2018 by the deal.II authors
+ * Copyright (C) 2006 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 7694f9d32a3a07668383852c7ff89c98779da1f3..9fe610b8174b79a80fa4eeacc6dd8206b78e627c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c7706a504ddcedbbd7dfeb73a091c73228b7f78c..ee9e6af97b1d41c52cdc700c7ad29296164cf75a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2019 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 700536dec2208f9a485b8c20b635bfd30d782332..4baf9afb9740d65c133d41d573cb51ced2b3f7f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33002f7d273f8bb3d1339cd41585dbe5bff70ecf..b7be41ddd041f0489d22ed927162ed798532586e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a3728c7d3f9fc663ffffd8c05874312ce15aed7..97dea68355254a2a719cb18dc61fac2f2d1c0c61 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 76182a3d34350de52200c3d842b9a2b5e3afeb2c..e66f11926b7c78ae21deaf646fef3c3ecbab7df0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d2db05109f3677fe16e594aa0720a567ae8a42e..c8bd6f11ceb237ce649bd74a4ab74a86aae7e61f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c01da3b8eeda400500f78141e541e9205244e7b..3d9aae1c4a2c71827f370d8c148482db9d8ab7a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12e22622755cd089d609bc14f430af992e6da983..f4ff982902fd2885f3937ca0d63e2c90003b8962 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 021a8d11cc30629d24f4d9286c2cf6001aa5cc65..9e067c3391ae4300f91486d0c1c65d0299f45764 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c4d9e6210f56d106f49da52b7014b9048575f82..7264d8e7cc0a9eeb66b3bf77bcb99f97c2d22752 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d096df5e35e02188f3f6c40bcec4b848bdcbe2be..0ce35f8c428cdadc67e53cde9fa323a997057c88 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e13ac6474ea7f4bd4e2a7a46f8adea5dee9ce21d..c412efbf54298a3f2844efe8919f811d522c4bc5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66b4277f5538fc9857968856d4c4202bcd6f071f..db64acbbea9da9c20f03a24f779bd27413e4f374 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab829961c32a109f29c94cf2fa13cabd708aa438..09cd551c5e67789defc4001f152ef397b6e431fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 40958e9af3821e54eac965b14a9ad9f5be223d91..120e26a171c6af9b4f94c737c2a38d1523e18b9c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5fe0702ba00dcb423d7d0c761badfa53cd7f445c..8f6ae6d5ffaeb36d53316f89269468755971990d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37a7fe1414c62181c9e7582a9256eb26d0275d66..c50d09de7a8ca56a9b0ddb49882f7244eb157a03 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2019 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a298f1d6199874715a4ac5c4000160df825c148c..17611d531cd573983a1471fef4406122dcbc8da8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2019 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e628e27de15c51a731a2cfe4c77f9edb0d6fcf8..c4e124d1146a7f48e4c64186db06ceadb1b16909 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2019 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ad33e2583446b461223a503ea4b7ee82121172a..6668bddcdbe565f5f1133735a34dc9b1c59833b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6668f87ff323d8b960d8f886dd72b10e3bb562bc..1f3c56248e2320d0bfd46b3f07b859e759da9e9f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2019 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 53754c82e743280159c17f0cd92a5a41f5375b8f..b56eef727bf5e68907ed0a40b0ec8c7ed8b220c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2019 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4364e5a8a094020aa3f219913ee51d6a5bcb9c1c..08d90f80b427230d4494ecf0f31ee70e7939b2e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96972e9b95014c582322a15e205f96210778bde8..f67417d745b7511f7025f2009e2c229d2a597561 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // Author: Jihuan Tian <jihuan_tian@hotmail.com>
 //
index 1ac974c2c639b2050d7a0e533489d689c7d171a9..b9e42f8806252b01aa5ee84049614c62f699095d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1506082b74836dfcf5152dc90b4d62e3ff870c41..313071cda877b44b8cf5e771b4e70758b4d94367 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ef65364ea462977f7c2739328a5352f22507ce5..4c14dd6b23c1e893ba01cd71cb59b42477ac94cd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6cdc9eecc734aacca68e712190b5a076db14e82..cbffcdbd0f4b237addf17050bb61575e39ed86d3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da9b7514a07ff13b847ea5734ef00a3b1530edb7..0e5f0b9626bd1588dfc2af0bf66cc34b7f3c7a23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c78794388caa731c6bdb6a6acd2d9b942f365564..34592b0447541f4537311c6243fa609217480282 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb3614f4cacd7ef5ac99e6840882b59617600672..878b2020eec02ddba3e51290e4e22dba07868d6a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e993decd620279acd75d5a65cde39ee9ba0c4cac..e88cf96989d29820130423c641bd643b8754abdf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8bb174bcf5c64d58868ae7fb0de0ec44aae2bd63..4178eee0f373d4bbfe758ab7db50ceab8241ee19 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3c3a14335be69562a64246027261dbf551102f5..15c274100ed2592fb7527629e20c82011096efa3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f64d6e8108a973d33a9a3cc30cbfe7f55dafad58..abf59443bb94ea7828e3123f36045b0a53dbacfb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf28a2be0cb1abefa11f1347ee50c20db9a8cebb..e482dcef4d66ee057fdbd7ce3d8fd3bc40ac4287 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f37d250b346487158b46ef3849be66edb8875209..89c9c073ed75bded2447250faa8f4aec7ae8198d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd1d8dd6d33fc15a9f6b4db5f340210ebc91b10a..eb6e0b0b418f489ca8b20324ae7972a60b1193e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed9aa8b2250e240f689fce481710233c7898b0a2..fdd50ca0a0ec7624843ecb317ed14e5b8f169b3b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7cc1919e60122a25458aed36647970dbe2d75c76..6b05d06f649304f83509a188275c83de7d5b9f6f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 724773af245f5942f198b98e4e58742f893d3a57..80f6d1059a463dbaaecab814381e17f09bcab96c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e301760fb3f7f5e8fb0476cf0aa7aa06682b637d..f2e9da603466dc5e991cbf4d92e01c058432bd27 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a3639f742b881cdcf2d4dbdbc2a506e16b10a42..c5f3b29baeba0fc9bf2389519ba52b8bb2f453ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6f5e9d8c6967a3f9b39e8b89a3462a4dd92a731..2cf1d5826db9599eacd55e50ce8aed26720d5751 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4813c9a4ff693e2f71c8ddaae3dfeb9fb6f4ca0..70e33b0fb142219c9b976cff29dce48299d22613 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f695b7a54603029457df358f5599412ebe5c8c6a..a7c865505dfa7b9bb01208304bcecc7b7ca1cfe2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 29e26dc10548ca22b0421ac8ee79a8e3135abe95..5d809ee790b9f9b50a20aafc22dd8b440aa16012 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 510480b4a50cff7a4aa10eea7b1f9979ea8d0c24..a042ffe76a97ea93f574ea77a9fd9cd589a40760 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23b6661548ce49010de3e230967863a9ff6d64e6..9e5b6690576419611c2e6b23f41f27abb24e5210 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2019 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f8415d13e2794cc9acc00f8f63c44e566253fc58..f1f0f91752fa92a491aad81c2f7aca4ce70afdea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bcc00930ab94bdb40c09e6b04f756569b0a09aa2..e9acb9aeb1ad3b3be731cef5ca40572fc7f13c30 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4001f338b91e058f45a04a6470dee2e60f214815..d87f380a111a8f355423571f599c8c0578579879 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 863bb9b1366e52b27d91e9fdef120cacbe9bcec5..cfdd4d9f6fe7a1e5065c28ad348ea0b9378ba972 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a35ba867467668c8fbdaec23eacd4aa67608ae4..c109d8aee4d0d55df73186a3a3ea832247573f84 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da65e33ec175d732099d64c99c523c850177e04b..c2514c6a0bfa8f7e7fb2452d891a10ad3cae5d70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0fbf476e06b512474cb47f6f46e6c22f84d0561..9e62b6544a2842ae525408c6101435847f581deb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6ca8959d0a36a2bced1e6baec2886087251555e..fa507a3083f442dd24cc598645950de651f615be 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e7caf49b00f8200deb84a321b00821f494690ebc..93aa6ac3321f69b04f4e2745d65f7c5ff2605929 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b00454248e87c1869f180f17f3d6788cfc47187..40a04710f9b4d48944f665fb9273e0dee5a044a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c77aa6a38c93ea5aa6474defdd929eeadab52434..c34a13fcbc6b471100d2cb0038548a0def39974c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b7bb46993bae33c477f4f591d2828de65c2605c..d61eafaf312c146b595acdc93c3917bcdf6d65af 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e48b7ce0bda15e548d9c78ce144c85d535c65919..cfedbd588ff2e83f06408f4c9605885daa251268 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ea3baf8b0aba1e4bb21e957e430566fb3444ee5..6cacad2beb27deb52a1f84c633a8faf02b81320c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db1ae815ca72e4cc5ea1a35596631b4153c39aab..db3f4610ce975e3fc4cf9d9190008370224c09aa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca3ddcb25958e39b7e43afa167cf49e3337dea1a..3d284c5e39fd53a014a3005d3d56bb484743db38 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0765fe85676eac6d082b11ed30442eedefd02bb..cdacf44cb07bafa249f43057146c092597aa7115 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c31f18ed08242e5ebf98faf41a52807a8bd2d4ed..6cfdd0c9f3e806da01e4f76496dd7f2d433ab475 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0c9367f12cd639c17e5c26351ed29d09a4511df..ed2488243d0b0d64c4cdf4a5dcd1d13bde43478e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d2e5dadb10b5b3791bc4da0cd4825e074c736a8..fbdbd1dfbaad179d9424bf637d3f453b4a83bc92 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2be68f9c5c4674b63a1f95645b17e940361e5b11..56457dc5a9e4ae78c4b24906a9a5c82c8d316ccd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 844617c3f626b5b1416527df9da6d8b76b2acbde..6fae8b21562b250ef5193336812eb1ffde7f2c84 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c90e6c8b48ee61384d1b16f94378c2fa3963e2d..18eb301d35b104afde4cc800b76c76feccf7e8cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d331eb18c2f232fe279351ba5381db0e149b714..e2e3da93cd0014d910b423f127770e7c27127d85 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3230473b710befb89551d0b3932febb3fa8fb424..a6ea2d272461e6e2cb4ea8a6934f5114e604eb7a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbf9571447310b0382c1e64fa5b111a972866369..d36f5caca74f818a935cf779c4ff112620fec074 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f10a9d02d9c92608c832f571e098bec0fc5921f1..90a4f7344add39dd3d75cc94216215ee67263748 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96a4a90aa1cfe11ef1085dfa52fe5b6d24bcbe9a..d01eba272b8c55468f52c17090a9d961dfab5517 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b321969467084870af8c065fb6a4cfe98a3ef403..dcc286591fef4a65fbdfb5d2b13b961c2cdbd173 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 057167f2c8b5855afb78fab65f0ffb046ff0cfca..3026310c5ac11376b792ac93cd04a9181246664b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 61d3f0cec8802711b6a4818779cee010af1eff9f..19471ceae461773ab5c31fb7b8cae08ef18f3036 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96f6d127e28782c5c63791b8ba400b8169dad450..b701a8ef030553a6d53478e8be491089f932987c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index baad2ac06daeef30d3f864ff48f569586de6b282..4341cb29fb3c1f15d24e3b736bf2563b9e15d44c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88734d847e10323716971b207697f4a72ab954bb..3d6e3a914d4000c0b906f4ff0ea74a98a9ac50f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4154efc72850a2cd540330cded4886a7ab883d26..a368da110599b163ddd08487b23c4ad86797be3c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c4dfbf3a0a7e29bf49d1aa71b8327f54c604e307..e32be3719f59e238358aea9153be4e400fa52dc7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d5162debe9e21ff4e4b5da643e274bd9a2d8abd7..1724b4e1e95ab3e9df730ad2c76ce254145eb2c2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b76a8343de7d1fc9c27221e1d6c2baca0b32c5df..dc35fe628213af965bd9de6c5b1fd65912241b2e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1742761afc03730422dc52baa1f166f1936430fa..9f7acdf9987961d3efcb50378151b3f54b4ada25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ac30b090b0bd72b53af0759eeb47a6ea705de0f..c5955c7f2b7d7625896cd4f78b9df70d443935f1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 999c9e231d8658dd8837b76200b079b1ebd6db13..a38f5d07378767ffa507427051652ea97399a00a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57efa68c68671578742dc416ded77e3c69279404..ca30e689ba1ac358c2a857541b055a5b6c5d67df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f8f8661bb373c8b9dceb56b44e086f687662d137..4e082de1d1fa0141f34716292dbbcf966455933a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index deb37e77323a3eae746c8846749ed489d5b4266d..b5ccb7ec5f4816aeb2f3390c8030169fe9f12c04 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 019a05b7c29190619009c436f200bbd96fa10956..598e4025fd9773577b248a0b20740c5d0e815e78 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f8fa2b8789c4c788e7ac31521cbd1cf461f26fc..6f006514421d4fafd94afaab393b9e8c6911a131 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d33a9b02ff63a128383e4daf01b5745ee937fc70..2f0d2393201d1babe98f1c8a85728a7a8c880a35 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18479064ad97541f44b96139e79fb88ef0bb6fed..2a70f3c605910424d1376b51b185a00120688b27 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e20a1af7780b29204b9cb159fca86933cf3dab49..511cdcfef51418df386bcf390a1bc1bd55004dfd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ccf72a0105dfd8e278ea9430c5f73d2e445e37a9..2497cb90ee7513d907cad28d45739f75a8bea69c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e571297b4536172ff04bf294b956d07372d62407..02c27a2bd4b5e077856199701ce17808c0459edf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c240a7bd3f22d6fd48f6fe089e618583b75b2f1d..5a413674048503239d226d5733bf6fdee1866f9b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 212cab834925495c5f59138938dbf01af70c317b..27f2212747dc2b0359958f5a930475768a9620ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b95f1e6a21e14366fbfb346c6d8f192dc440b2ed..1d58b116ec09a4641fc4ef7db167fed5b6c88d20 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a4f3d161edf0cefb75afec1452dede34edf12776..95cbdf2277f1fd357df362958c7ad9955d9246bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37fe0fc5e753834ca335bbc6d8159341965e3a15..3687dbaa2336cda554429638176ae16aa8592769 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a475da2fe79f3a8435f7c136da688131ea440f9e..55d68d263f37b2a37122fb57382ccdc8e755b859 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2019 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ec52d74994af362148ebf3e699a235e1a38ce40..f51d4553afbe41ea8688097e9a4d6a4eef126af5 100644 (file)
@@ -1,7 +1,7 @@
 
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c82bc1c96976e4e56226daa2c00431afed0878a4..f85aaa46bdb12fd5dfa95ad3fcaa6b012ff0d38b 100644 (file)
@@ -1,7 +1,7 @@
 
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4270c5dc4e39b0f812a889e6cac5857f0ef4ca99..8ff760030f61d893b2ee02aa97b3441646945a59 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eec7eab03bd5bc451520b3476c762ea4719a0969..f83a6b6956f22dcd33dfa9c2f226f51ce13359e6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 00a962feb0548d73a322db2f5ba15e19d6ca835b..1ff91bb7ad0a63fb56c3202525a1bf3318ca485b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42d100d88490059821ef0760a2c6498b83252d43..16380565c65eddac1f65803d14a65a30040602e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7eb2452db419e2f5a2e661fe716d80cec640bf84..d596c6e2992044aff8a7e07411b7db91a8ec1671 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6b94f3d7bfbcdd028fb70c6236dd3e258f0ef78..b5089c07af804697487f218236e3446422e26640 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 285ac55538815298f900e520b4c61632d77b9995..88685532cae734c0afba2d4b0f1565a753f50be8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f8422a5b0fd6f66cb7e0af93a7069923e17bb25..71e39e34d5861f980d5a17ed3e237d6e394edbe3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13f4b5bef109ac0e85f1f7a847a3444ffeb2b294..970c988d5c18a761593cf486fc9370bff468f758 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 784b85b13622f151698934a0bdf5df71d035f1ae..db0957ec88e791171510935255e4dcc97165255f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be6fdd204757b4a248f5c4a2ba9e5c87bd37c036..9a1b7c1ff0305a69c723c18f64872a12667f9827 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b8bfbbb3a6a3835853e5a70f2a568a1026aed1a..ba3123e94b14572ef8eeb197b2ed807c69ca1888 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd16c69ef6d89cfb15ba53df0d06af9d33e1b3b8..5ca23de6da40d0883f272c10d86c2ed1d6809957 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39434b343a201cf2676cddd28a4c069b1efcd9df..c77abfdb60626ace55845bb69a77426c25e86abf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b70b78d611abc7a3ea6d052e97716e8d15987251..3ef01ad001812a06bab94921a99099b7c976a5bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 319c1f23749be97f54d23a8b48e77a2b1000ce28..d22a3235fc01baedcaed6f73be173c5196bb86fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7357241a1616de14ef81ccdda302dcc9ef1992d6..d9a57edb784ae64c05a1e308fafe9686ca33422f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f65070e3cca2a74da083264e47420ac45d71d0e5..2639b5142564042475d1beee012f9cfe5d0be762 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25bf3ef35563ad0d72be0178a61357e81b739622..7566b9f8b9208b706ad7de7ec7ee2d9b980f9ccb 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2018 by the deal.II authors
+ * Copyright (C) 2008 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index d6a04c18aa35201528b660cd835d32decb4a14b1..2bf823d02c742a5dfab6eff636c0fc02c1189387 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 723994cafcb10f9a83def3570af21766ae34b46b..354fb8678a0554c7cd14c6695e34e2426f014879 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a403818f5c3ef6b9218d95f73483827223b61fa9..8d77ae0cac1bed2c697c8c5d435659f740a0d3de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 36667e5c2201dd2d9a7c65caa7c0a65f8883f625..fe7547113cc72043977617a44feddd7d1eaa7ac6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 89895ed74adbda96dcd65fef78e0d068f1f4e7d8..32b27c2eab8fb35e1c381ff310e2051b907a375a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81b5a19576751f24c631ed59bcdd3b269c02c202..dbf0b7ad7f34e08a44b39b20652659245271f3ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 412333a1b4e5064eb7d9619936863f136d39f7f6..45181e3a9562606eaf82f82a28122328998a0850 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6715d13f74388dbb3fcd976ff8c5f101a2d52ee..e24bb5e633440136bdf7b1e382531364f2d263ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af3a41d379de2840e1ac6fad664689dd649aadfc..b61675212343c91c94afbdd54cc572f2dba5c9fd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e583f43f3a9035f81afd48cf7a8ac939a0873706..98ccded0cc49ba53fa75a5749be04dc9fc32d489 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9ecc9e46253110fc758a879d674b311a8c49340..32eca8aa7d1d979cd4c4373d7e61319cd7cf3ce9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 602b7329c1163db8ba393f0fe1d9c8f189208bd3..41a1cff127165f3a73b99ea9ddb02fb30dc46374 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75a0cb290d634bda58a75dc545739b8db4c1095e..d45c998c75c69f387d6eec280ed6c43795ee26b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60b59fcbaacbdeb0d9530d8d5d99f7bdf20ee1d4..bf5bdeb32de869711ae2d6e4c6e71440f31116ef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3c904af789d61eee46273c125064c692b6d5bbf..add4c72c5c2c8b354dd3aa4ba9efcf277a390bbf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3455f305df0be766b2d329b4f24d4747b8a92f6f..7a36e37a498a3934e08c179b3e600b2b02e74642 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfeea1c9a016890ef1ce9a1462a393adf5a33fe2..c50a5b26d5c57a7d16039dc4a8f4893d262611ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec58a1cdbaccfe10e673f98bc38779ddf80f041f..12abc26c181b233e3d991f3a05a2d47b04c76a73 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 83f64c275ee508f78261e891b71a3e4576ab40f7..554ede8b41af2051d6299203159efad9781ae4ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 000ea875a97a6ebea73ea9cf6ef9f7f9e440cd9f..4356401c3d21ff92b889cb059c3521b0edbab15c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba84cf7cdfb1500fd12c31db996364951c989f16..c0bfa0af747ddb9fab0035ce9f1c703d73dc427e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ac097ba85849270e2cb5488b29aed7e85fb66222..aa9f25cf8bcbf8e5cabda04967fdda11c4c9eddf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22085555727a9ba2be6471525eeb0aff6022f8fc..54cdbab535153a8fb70503621a79cbe186897d3d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95122473fc4f6a38a86edc3499d8ef1e8eee1bd4..6b842947f264a1a6d969d0e5052af4445c580f78 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5398505a6dbe74c03915a75905b31013d2c51bd1..8058461f54c06f543a012cecbf30b1c2b6175a34 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17a0af07f74536d88aa219fcbc9a540ff3d35900..73b91514ad52daeacd816c9ff6b20d9dad072dd8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96fdaad46c357d1debc14286fb75efb674fabb9f..1486bacf6f45b710782d36de6cc4c6736e50a384 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e3b91465da0eb45d35321168e90cf3a06feaa10..117a93b6115c5f84f9a9c9e5be60f93dbedbe013 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60a7b6eed41c7d01b8a452b23bad24b0d82dd23b..4e0b79d29af0e143621fb81e691960884c4772c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81134e006105d2bb108c51676cc291377f0b4541..b805276f3f377a0976d223195383d599478b0147 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a390fed111002406f1dab26bac48745ba527bc0..5747d7435dd234bba80bece0155d94df42141a49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e64c431453b22902f4e028696ce03732136fe968..bf958102b7d048d3447e004db0b5f9ca4e86ed9b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34e0193f9328b667343ef9dd3df2078f21badedf..87eb1e0eab533378317a208f86166a2313040550 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca48d9d933c1b9f6bbaeb9b7bbe81a383c72228e..e3fed791c9a698c5e141ff36a4326c880d595796 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63e439d83b4ceade62ad67764227b0592b6a2cbd..db6112347438755ca6931d2923eb4726cee2ccb7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c645e5d1c1a9e43d3ddea8c9388ad5f2b9242156..f56d691679d23b1a5b482bbc0899a5c1ecc3dad9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f945172af2818ca497cb0cc674b64731cecf9e42..7c9419b3fccbab1fe89815ee1d4cb0ee3aedd9b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a0f155acc7d15d7b17c91b7a8e429542c17ad78..0f3f9a0afff388cc938810f658e0f524f88a3ed1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e68d5b3a082f7ad47a37285fdd50c392ee488d7..4ebd896da3bc345583e5083de10b70af690bd42c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f8c097546b8f4e2b3366148dba15519a17a523c..324c881df3e0af5d3f58d7cd910cc5a4a1039413 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2017 - 2018 by the deal.II authors
+ * Copyright (C) 2017 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b578216f55a7f83033f690d65229a11eaeb61837..453f43a5a105b36f2bff0a2b2aac40ae6a5cf597 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6021ecdcd17828e99d35bf410fe8a1f6ece3c2e0..b7256f180f9470522c5b6d6febef665693d981ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a99d6004f4712442e85cd0a27d3063c10ea91626..2b34d793d517d496371bd110e6831d2db6db1cdb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da4725d7b215eacbe92190e99da45a563adb06f3..cd5248f273b170ac72e5a11be732d317c86907c9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9180ad3200e5ef0204e3b6fd08dff72b712763cc..165513b4a366d36a2bcdc69f998286e8050194e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d87da4a684a6e3df0ef48ec6f97ea50e266f7d85..a1bb003bb8a2c6e7ff0f9d48ec407399bca7c1f4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0c700f2caa1f7d39f9197aa94375930f4288fc0b..3757241c9c108933e5fc188f1072a8878e939f0d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c58610e7409a25623c61accf0555ea1b7d42644..c8fa8e906dd50820c513cdcfd0f0ce0512b5273e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2dc831bcd0c707ce3c3b65180cb2f9da986e8101..92f574bf24332f1de0390c4b2c7508ed582ad984 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da5fdec7580f35d60f5bf8a824f9663d702bb222..1efd5c2966da6592a2ec04cc48f07c07f7930a1d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dabf769ed2037306c8ab631755ff16e422cb5a73..17b2f478f3143543d143d269a984d1c7c0bdb5ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index afaac64fec8df30b38540bd4a1da32714a129cbf..407c1b5b87e27f0a0f914af10dda33f0ad34784b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca2374b9f46a365db250e229fc94b59110b1fdcd..ad9f94042346fba209da428b3bd7427a8c3813ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5639751e3c1d0b11e2101c43b763e594382e83a4..4905e2279b808cd1b921680ad32b07d29b30f1fc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42a002cf9c927c8bc8bd9595f4d239e938778331..218fa3d50d7ef0ae7764b71bd05334db80091cdf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0c97d15336718ed4af556bf12f8285cb11f8181..174ee6f1fabca0fd9b12323b1775d240f49fec42 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2610dd8d30cc67475d21116a477f6f6f13fdc757..07a177f5f8cff234cda8e342c9acac8df7105bf1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe8b39c2f1f7b937e30a5dba3f9118d67f43925f..af4fd0ea1b00d0e0cfbcfc4bad7b3edde2620f75 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 979c2c8c736d3b58f3f7fb4a909897e3cb5ed3be..38e130c54929b6390d94f0b32fd02f002c8886a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec9403fc61d49fce880b5283986d87fe4617401b..b4e1472502f29cd483a5afc2c69508a8a521f6ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0be47637da81236e78645e49e21aeb3bc770019..56a2b791c61704112e138bd5e20b142d111d6062 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 121b82536855701f8b432a694501174c426f60ef..9fba1558b194d90bd547d1bdea639a6feae66185 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c93330368e5e557d1915a9d32c2dd0068da05d90..5e3aef05e6d3726e9c4f3d397ef6774fef56773e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 157b2aa2ef95e5a8f3aa1c7d026f1f84a879849f..32b1760e20acfe2d8551ae09780505e6467fa472 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb5961b66f32fcd2d6872a5de01b9cd01ce59f3b..bd27d864e1c2a64c61883bf4296d2a8db5904e93 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b88e7830a45b3eb71343cba6d5b36a448224dce8..cd7df6131d66fd52d4bec1206633551394b26a92 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4ec9f1f4da5a0f9db2ae1a1c28ae061905094bc..7b4146a5465e0ee7d57982c073225d5fd3888cef 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5d41ea9a03590c6dac1c137b7d104f73f12f13fc..101f83aa88882438642ed6c31fa64423ecbf6def 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab7643fa8bb529fd5b2e8830c5c79e85bb8156bb..43171aa16ee55f69cf36c9c319d00c8cd06a353b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 630af3205b2b9389c81f1f0a14312b9218ab99e9..f3bcb3dcacc622f0412a9977d206e49658f489ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8cce6f7dad8f911c40e64850efd4cb7252b4c7bb..53b3346c1d02a1cff742eac8560bb3072ccec24c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e45adebbacd29265c7436432e8d48e48819d0d19..ce445e24b00b8a69ebfc6af639be56f7df42e072 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b980d70e8caed29a1f1dfc7cddc1dbcdacd6d06..e3a70bb4332ac766acd874b74cf21fd31f571cbc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3afe831ecbe378e0a5ecb0d88f52ff97010f414a..62320697c6836e924e8ebe72ce4005f237974bcd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e091f8c69b575a7958ebc61dd9ff99d79632b30..04aa476104013a1d228de8a3cf169700f649cd85 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc065b8537a1498100d2b0e31d24cafacc5eb3df..c9e68db9ccdd6d05ca06af216dfbf4deeb496d0e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e71ef8d37f1fde692ac8fb94736d0c5e715edea..6d6c28994bb2a912e8dbabb1c7605d98c8539f72 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5f4541809f6cc8a2c7f9ff78743076c163e5c85d..72058827bf1bc9118384c3bcf893e2ad02d716d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1828882bd8384432cfe62a9f8d92d12b88a86bb..e80f9c401eaabdaddb9d98703d32c4b8d85ba778 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd590f384b599d7e0a9763e20fb92c2f331f699b..004b449a37e17235ea74f308416a9b9361e1554f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60059814ca150b89ba4502d4c2fcdf19609e15a7..503948395ad0b633bfcdfa824d1ea6818e7214a1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f16b38cce2b93a9b02f96821e3f308e58f2c02dd..b155dd3b2dec42e6435430eef147dc64c8198c55 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4be45c4f3b559083b99a26c1ed617d36c72361b9..dcc9fed3c6789d3b59d7912f5b04eab673127380 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b81462a90fe4ad6397855f9bec3b757baca4c4e3..c151f1622cf4d1e11fa39e56ef1168ba090523f8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb49b780ac6b3e0cfb05be99dce1fc570c4e76d4..4322e3f1f64382e6586c1e5e592629a71cbd6aa9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39c0252f946dcac1f138ba1d64cea5f0b32a5f30..a0c7c6507a29e4ddee53d70757c2d655ae3aa773 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index daa3de6614608bd114ef8cf1e3789d404cb4ec87..81f96664b6ab0d22b0800ab59a186f2c39aa4141 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ebf95800c6a442829f6e4ce408911cebafad2d3a..cba9241de6412a836509497589dd70af9f42feca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1bc95dbe4d8a2a4400954970edb3010098a57eb6..8100b97eb3b9347d7289014ecbbf0d19a18ae2d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13cb4633a04fef2eaa1cd728882c1a4b931b0791..4c0d0d6700b2ef1347b51cc619acee8f594287e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d29217e8622c6fe93881f01d4d04d94287698ca4..8749514170e3deb439c1c9d150fb57fed2dfb861 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c10b5b4bc90aa86575f67a745268db2f0f98a361..f46f1d5e7463c02b940e48ff509b36d265cb8eee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5febad7b55eb77bf6f8a7472dffc6281daa1ae1..dd768dd56f2f35d25098c82a038cb86ce1818f71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e0953642541383f2a784d18d55522e2a99f17137..96a3043733006239def83e4621ee00d4cf18ff81 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1e9771f74790afe65552cf87ffa4ff946711b3f..267db9bc9112fa52729ce9c3a3742467e3ee114b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50c0f999616720b2704915670bdcff145ae7b05c..9591123b98e94de585620478cb22267d16a8af0b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1216ebeb5fe1b5d7d23779210eefe4b152c787cf..970e9bf934edef1234824652570542104f99166d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5df2e756008211d45fa7d507e862fc91d8d93bd0..cd68af390d5a3c0419193d181c1e70345383ee92 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 43c838f1405492a6d03460ca8451a3c5c68f523b..de2208f23ff7181c7566eceac8bcf812016aef9a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b79ad1700da101732e467f0f03f018071c2c8716..1e2b38c156b4120c668527535fc1cdc9cd613a43 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11c062866b1e428016d895615e095466e0de9810..68a1d240a569b5edcd2ff6e9ef303601594ae471 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bac54e61fa324257d68d682b5e1bc059b70d019c..1b4ca0315c624bd65d755922946fa55523e47a35 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd01587c16b6cddc332dbebe3135c904a51e851b..ca6ed18c6a95aeac9a142f6d85824e16094da24c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d7deeae93d493d1bf93388a48732277a9eacd7e4..73fb528bf2bb0e42e49aee493c135bf8e897e2d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6359e37561bd693c3f2e0f190824ec5a85154ca..e64ea881714f88bc264baacb06a844c76c1630ba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c9b864c82f633538617639b42051563c9401689..0dd290ea822d98a83041258e7c23f6be4b4a9cec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23421c9ac9e018f66e7162641a3954fbd51d320f..d80947c783525aa80ec6c7fa091086ce311d76b2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14833e0278d61aa2a6dcf1b0f32ed69d4b33f7e2..bb1242c9db3df64de8aff12df34d9b3b94d5730e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c1e45d4c8a4f38d81f5432edb3ae6c8be52b79b8..103cab75c5fc0d8cb2f5b77c4e7c3860283206b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ede0ff57661eae7026b9495408fe110dd760f972..b94aeeeffeb8331ab18c166ed104fa8a01112915 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3164dcc6f8dd02bf6ccef0bcdc166bb70e055d2..53395abc7bdc50e0a1324058d5bc5c96336968af 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be9fcfef932b53ff2b16a76f12260e514f808908..d04c57a64720f2e6d178649d69628e4fe4b4b5e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 417691e25794bb0c31920207509bef749dfb47e8..d251f9ef1d9fb09adb27a84a6190c74b896ee08d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4d8a628f408fdc397e04e106ed9bdf93f9b4b65..16456475a7c6e0347dabf0095348c8ae55d4ca08 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d1d144d604a0be6292f6b7f50f7140896dcf9589..524f1eaf2656a78705044579b9e7a799e7919ef7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e82d95c1234445a00355ce1a915227e3805f9df..ec82c16f200e63cdf41db66c6e3b574476e15564 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7010f685cbc75bee93ecd444f99e316f42c74a61..09dc948cc4c82c9e27fd9f36563f45e9ab2a27c2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5d9924511668e9604c07697a66026fc079b6e3f..9dffd48c076b6345070dd08525e5498d7778770b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a206b600b8cb66deb1501d74f56a2293c7630603..19e86f4d1e708d193348b9b1fec24aaa5bd165ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98e6a015bd82592161820dc5c3b53d6e15d4a356..784de1c32fcd707fe45dfa254d62dd4fbd38e29a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8e4c06b51aaa4247d0c6a04c14a102deafd599f1..cd2fb4192548615b8d78a9310f4dd13f1a8bd9f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba05bf4adb1acf555e5e90f12d5d3a1bab6dcd92..b651a67b2cdf7b3110cd20dabd4bf6882ecf4047 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60053aa6175e1cefe821e0bda609ba2b87bf3d23..861c5ea7447460f478f75490df91bb0bf545eb32 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa4d6c394427f85e3eee27c219de1bf15845b747..27ceb925d43e09e76a78f514b81932a95745bdd0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index edc5c24cefebfadd01650102fbad76554cc694dd..05507124c50229b0c71f76e87b3e932a2599abe6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b61716d13bacb7bf562cdad8e772c411292d9dc6..43cd4311bd10562dd9ff90500528311f8e057c67 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b7e5fe8b8adcd426f8611d997f2abdf6586a99f9..0554b5741dd13325e2bf5462332e883eee1c30bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4816cd3a4c530adab7d59127ea0b06cf09849efe..9542823037e758a3cd4d436d5c902e282787d266 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8c2de55924982d43b5f69964bb4e232fd6e0336..678082e1bb8000f693145ea2de47c09ec0695a22 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fbae11dd4abb2e98867ad0b6842239c52ba82622..f6a2b331ab768f7c83c3177b6e70638bb3e44376 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e7ccda364298ac23de1131e3563ac203c140a289..a68037d8faf71f0bf639334c954e4bfa9f40cc2d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6c196e316f01fb8e6028728b9040b68d483f1d3..cb0cbcc728ee8a4591d90ed025420eedb28a1b87 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf5a9657085b125df0b4280fed02d1f0a1c60fd2..154383380663b868d014c90ddc709d3f0af6cafb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd0795cbd1067bec8f3075d31529c9848205b2ad..6ea4e6fc91877e347fde757545ddde4f963b29fc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48ded974fe63955aa247958053aafedf5aa99e93..9a581be4f42230e1e5a81aa2363b685371a3e9eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b7120e6ece7e7e3e27e239b221b1faaf5b99f2bb..16ba7ddb2593530eca52238c48451a95b4700937 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a34ac417904212fec9ae3877f2298d8d1af358e7..d5ca36ace7f6f7315c2527ee9014a93b6cd92203 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea10d341f0ab8a2e58d6c1b540b0656ebf04bb8a..9abb35bd7b5ada768efedd9afe8082a0544940b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a6d2ca711f0dbaa4d70425b93984e085e1d2acc..099de19eff35d86120c0d493de0b3d1304db3c60 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 084c376fe05afe6f392f50703d40552ee642939a..306def294c150f923ca400efb0cff01f931f682f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d06bb86dfc0b3bdc773e38dbac8feee29a12a66a..e972a149ea2a57d4aceaa732fa4a4d5685f8f820 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f0c8b25a5822149d11c299f674903b1233b5aa2..3c6950990a66f6d6a622a6417929eab4f996f314 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4728db96afb430511bb29b7e2275c7721832ab5c..0d42bb6ead2861bc385d28336f7c1c5564698c4f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 41362d5819cf58e44d4ee60f33fd7ccd5d1585ca..69cfad5565fb439dacd9be6f7876a81b76435988 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95dff816942da0c9aaf47b85b866feacf7022aa9..90bbf9ca7a3ed0291b4916236b55a420445dfd90 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 539b18259196a319db9b51e77ebe7986568e9359..07652bdc79e024040bbe916d53d3eddc4a1391ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 870be2c220215c583de178416e4dcc532a17595d..228db4d7eee6c51a5639b589c1d21c8aa660de56 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d19e6e7ed552d90712b99bfe24de1dcd81d96ff5..70bf2f0630d771aed191c3bc3a3aee5f3f20da67 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f60ee86ac20acc58efe3f7957258744385c99bfe..0f6e9a47d4e5bdcc427851adef62c9405e87c8fd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c1a6e7497354fb2cb0c501ff3915309673f221d..ffea43045be545887a9e179e0375bacf96ab9775 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c9317f3ba2f8a9f21c7b2d9e06f553ff2d635847..f6257b382cc1f5911de8772b16ba2dcfeccb4098 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a283f3b9aec4c262b5b571d49b036193fc2c2c7c..337c85bede1a8cd69e7109c1372f7a29728e58cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4e89bd5a642c83226ddb3a44425dfb87fcfaf55..a4f15460f133c69c4e05422c0abda1b2f6a0c309 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21c30dfab843abf9ded2057a3b1574a75831c23c..c9336bcb84f86a137cd6ba2db0001e8f313a525f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1db3cc1d2d3c997783bafae3968ae1d950293cd..8bfaafd5faf800af7697fc03ed57055e9e49dda2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85062d5b675d9bbeab1401bed1c9304b65e97b8f..f9770fe5e7abd71194a89f2a7bd86a0b5bb1b007 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3484836f2b50f95ea80f45cbd3d222a38cb89778..8d102576d688bd776937422db1f7aa9df0904011 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9933de9a5dcb16db35052e56bc629f45d4bd0e2f..07bb703ee802e6f119451c0c091c6a41f154af20 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 46c1c47e240ad70fb0fae4edb1dedcf51dc73983..809dfd9925bba0117f0bc04266099432fcb2f2e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10e848d4f2cfd5754f992f2b9fe2476566f67a6d..db081f114af7c43d9d30a2382bcd15b5d13fe22f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2bdef206c184329b5e4a7cf125345385891bec3..10844eadc869284b7a9c55080cc12ef6a6b86ffe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6206ed518d5ddb6daeecd7106b4a759f63765c9..8ccd637d8deaf4f4354fb4e46c4dac2c688700a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9eea186af09de2bbd40e48cd5d21b9a730b4e204..6522b8834d5178dcaa8459a7694fe11c73b4e5fc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10fecce5f96c562880a6588312d2b804e3778ee6..df453acc43fd9be60e0948786303af2b1eba916d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0416ea031ff6db82584cea5344ad215aad006b0..ddbbbf66e29799d2864e47bcf5e7877ba7eb4ae0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b93eefa497ea6ae1b7acb33491ad9501f5102dcd..4cd6959217903647036e8ec756259beb34641cd1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ab473d1f73293417424db1aa13adc9ec799359a..c4110a8f65975721d49f092f482ec821878870d7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87d2f63c652d81f69f07f5b7bfc2ef2e1ba6d493..9a562460459a0ef565c679e28b9084fa6b953417 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fb09bf2b2aa7c68dfbb5ad6cd47994944fb9792..bdfd332837a90fa223f395b85986c1b44d573cab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 624c6c36bf5f913ee3aba4a0eeb0e16d350028b7..786221e9f13b5e2e5db8dea4b06fdb5842ed92e6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5eae41ab64ec4df7657e9adb29af76d2979232f8..cf0632a1c3b12e8d9d8427126d33d48dada94a3e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3842a17cbc2a12e8b4c47fb572bc9e4159d3958..cf5fb323c5f555dc6baf51b187b8ad900c8fe505 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ffe08aff39887827ec349bc11cc2fcc7bf21a14..ac0c7e1ba7fe4cbeeef089d832b1655a4f5490b0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4303a1f86a058714f6503f13a9edc70d30b94d43..0aa6bfa60a271b746ce5992fe3c1ee632ebdb5dd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ba0a542fd4ccbb9626560fca41b5ed2f02b4eec..f12532947a2347cf04819935cef7e847b9ede996 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c16d3669b8685e41e53487677eefef882fe9691..ccc321639b3b5ed69026f02af0f464b9238b3d29 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b74eb677600621a0963a524cd44efcb5930158fb..7253063fcfcd9b7f9f2f9a731252e07e32fc7c3f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 98ef87100096143ac537aa6c5a7d062da2c6b5f1..657472fc6fe47c4c1ea0f17a82da2d84b8188991 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b712942448ce3b57e0636a3aa224db7cfe39c191..20208424202119480276c2fc9fad82fa39e246b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8e78fc2826856fc09e57023bb06fb899119b3c15..c64e269735621831b6b79d0308cf22e0d820152c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17aac3574686ef1df258744990fe9fd205404b1c..c38f4dc9c348cc43afde343c18bc4880c9982d86 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c60da94a14ebf5076e7a91cf7c439104b401238..c9b2ff0712880bb488034be8ca00b76074b653a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d2f3cf98abc1f7c53342df5816f68770fddeff9a..61b25915be97ae650d93d1381827c1235423b47c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fb44a490c9182b7a8dbfc0d14ef1a95186e66ea..46fd94b6f7e2bf18d7166b8b01c2f9ce7d47ee90 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d85d7a85753d5fa46cd0861a7bb5c2bf541b834..33359195d3b922e0599769b5a334bbe326ff0d9b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 174a9a74922b838cd42651ad1f2275be7dc7346f..0377084489a46380386b1ff0d31e44c04d28598d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 989ed0f5734a3de2316cafb9aa5610ce23df5ab9..e2f9b439df213ea8b2dc8fd2a1e2035051004078 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018-2014 by the deal.II authors
+// Copyright (C) 2014 - 2020-2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ecf8af2099301363fc0a265f285d01ba9f534ae..69b21fe366d46c149be14aa63ba2e9b66e624e0c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8fb9bf94f3b5d1392c4306da3cc3b2e3bc054d6d..120b8d3b400ebeb81cbe3aba1c8aae3c3b5f916d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 70d9aa284e037896c6b9c311dd11c97008c30701..2bf3fd9c35b7bf69139c6b7b621f6f0805fc75f4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9aa9e51fadfeb0e1d1263cc6bbf9186ae116f230..351169f93639b3d332d5ece0dad775c420a238ed 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92d1db93fc12caf4caeb3c202d4daac0b9ddccbb..4fb6842976425fa104db3e60f87bb4e76f06e665 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bd7b07686e071fed881099ab48ecd04390e1144c..5fe59876e576fe52ba96c3b8076557f5ba03fa8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bac8e7879e7ebb31a959890f767bbb37a1080ad..7ca704858fcb02935a96321ad8ca06b707652135 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf61846e93df7cae775a58573e8d94e020abfdd1..eb0072dd773abb6a71504aa9ad23619be0fd9bcd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 364714ccfd27942375aec9ccc0e431e1317288a3..7266d334138a098911b58966ea2ffd21aa5714d7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95f46ed9658ea8c625e35e0875681300df0321ea..aaae3e46da1c9395ef966bdf5927042d05db70fd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 67cf1d29dec4c260d8d4d59998f8b64539764679..c7698baddda77b28ae204686068486a8229a40fc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13544de025f7612cf7013cee553e0c4d13b6bdd9..18edaf0a59ec1089806ca3a3c56f7682d674e07a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cfab893c86276e6dfc04a1af8d6edd40f895a69b..205f488fb42195e098015b5ee627db0aa6682b92 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed0e10c0b2ca95f0181e05328861f956ce15e83d..f8da4af1f379a1612583adb2b6cbdce525f234a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f53ca5c0b251fb3fe0fa45dec7fb43da87d2c01f..e339d104512947ab3fb569aaa8def6a9eb55d495 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4276006a5bbbdb09834a407c6790f3c6c257f30..dbb54ba61ce5f3e41c050544ea55b7aaffc20ed8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce14deb268ce90ec11e4feb2b1431a4b8ca16a9c..8d46de2e72f0ea30d638bd678fbc24d12e461687 100644 (file)
@@ -1,6 +1,6 @@
 //------------------  interpolate_functions_common.h  ------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e8f40f0a2b5cef97c7a22ae0a7a99a871c3fea8..92998af579cbd3e3cebeccfe288e012bb64e3b03 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3a33e032f3c41b1afd07609f7563f3f76892747e..08c88e6b9fc9b3e59985a67bbaa450a9952f3f69 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ddcccc3eeee62c80b4c0b3a21c9475f8b1eb220..07cdc064babb83de9e2f12c903b802b2ce59e5ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9bd39a3a0e70f1d85bb6e6a41be804f7072534a..4ec033a4bc596a823b05ccc6ae045579e9b716cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b8febf87e8132fb310be342f6e170fb362ac61d..132ce818990afc86b2ca1cea58eb89ed122d80fe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc477ef91e7cca008d37b3b36c2d869e712c1002..3f71e84f313842614cbdcbfe167f66a4eba11547 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fa5a07ae3a27266966147655433d097e42dff865..61fa4497b3c8ba641bc2ce233de0caf79b1eb920 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 798bed121cd9ad07025813fce11050ab35a5da69..3296ff034d5c299ec9ab2a1b5b05d85f00d84215 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f75c7175c1b682d2f3459a2cc2cd6c95caa7ed0..da80af12ed1072f087987c36f520fdd68ea86e62 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f1863eeca4a82f5a2c206e040489737b8469f74..903110315bfaaa599951ad03ca67e78cb5e49425 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 761051b24f072e620bfeddc9517d4ce25d0a6315..ae347994c790a401561f35d642579ea280d81c69 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85c94e6089007dc46986b473bda30089239ae3ad..aa12b4fc865754f0bf1435b945e4278382ee5d61 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe38be5f627e7371ec5c35d6e7c4bcb03439e68a..15e17d32f0eee403e481a49890b760b1d2ed92bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f836f8197710c19715c89ec3d5a83d3f96aaa81..b2ee46de78899699c4b76b60b50e13a0905e052c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 114b6e7ed1ebffe1513ff535162b876665a3f49a..33b87117a7a814082f465992f93e5072f39a8121 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94f381f856669fc114cefe3ed853e5c2ffde7b2e..1ae9195bc616b7229068e77d3ea350c4ad8535ba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 449e40b7768fcef24718240b07346a2606e06e9a..103e5b273e98a68707050b287d3c61803e2b02a6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d74e7567bc48182f9db552f02730d84bc2dedd69..a947801574cf7986c6f08619aaa455f00a309426 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dcc2cff6a9bbd634a2802d361a7d74eca634ce59..aa408d319145d7c1687ea3d2e3e53f2ca60d0c4d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 025be763ab19464bad7eaa5cdff17da0db345da8..2fcaeb87e45d1c22edc7ac4e42fc394ac4526728 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be92986aa8894943825749700d49d0824610823c..0a42a30dca869387f4f1164b44736222782aebcc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8ad6ab3250bb33ec4f8a652b09ff5e278ba5dc4..35f13eeb1c1a83b01003d628a38c9f863d39178c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4224727cdd096607efedf7b4b82fe84296fa9cb3..347dc930a5a3a56f617e98eb81e5e0584f225fe6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97723ab344b22a27dfc9ed03b9cbcf92a0228f4e..42839bc86bee426b254b6762ef08f9c1a08f65de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c16e3defe119d6fd865386f69e22025193786eed..52b2b573d281919c0db0027626d409316d2a2de4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cc4aa59858c5831c725278152dd9772fe5f3ab42..e74ab0c0c60aaa68039ebafa6b3ea56c9f87930c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8f86e88c449e59e469d1b56344b18b871d71da5..74c77bc83be96be398afa50262b6572bae9bae10 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9000a4fa289bc7adb00d72bb9d9cbccbe26f509..2cfdec6e12d0d0623f7a00f1131e1039d8f4f565 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e8be93d2c1f577a12e845109aa836e99ac798b8..970e4bc30bfc00afd34b7b4c5bd1c1e668dc4add 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04b2442608ad3ebcd95abcc31a5abe92c759bb6f..90b3537eaf97bb84ab55228fce6ec15b158487b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a60749f071bd6ceff8108e80aeeb097edcf9ea41..36e9fe8e486820b150dd43614e2d23dedbe0286c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a667d6a97c7fe85e23cff482ffa3f5422eb217ab..430cb5dc83264f719bc1afc7addaa14bc8ba90cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c513563b7803628fab08f3a6364e518882c2ae57..82cd8f9fa8451f5a367463def1e6888f3bcab934 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c7a5c44bd3da05747a1b653a1e687b3784e79c16..5baad3d1fc094db2f786e4173d6e7a1bbc23cbc1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0fb0250d766b395c9fedd5ae93b62f6058c78414..b481e5bbe8bdb04a1519fffba647181db69a5022 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1cb372566167da2817068123f64f91d5f56f7b88..8abb641fac4c17327b30434694399e7d72325f2e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8eca70a3b3509cfe80c1642c8e9a44dce7044b50..e8d16df142d6622eeeac371e8a5cf3b7f27252fb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60b96837b454062629561863ceb51ab49d6152a1..d71c121a74530ca0c379ba471b5f4bdc8dd308c1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 99320148a7fcab31c3d361f23b0f892acc421b49..cfc16160ed728111f087a495aab117d56e076a25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f97bd5564ca9c7716bd1b2d3c7c1183ed8496f53..1580fba470cdaab1e3ca62be789ca7838f9ff443 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f8faa01dc4423d4783d914b914bb3573f302830..aae66e66c8b682123984f373deaf3c2af9ba5c41 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ad73491531043a512dd9d89c3d258ff166e837a5..358990ff739009da2d47abf25071bc1f800303f8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39d1a17e8ce7e012360b8d2810b25b24a6bc15db..9d2e5a4b6396d0c18a6b53bd03eca4bebfe5c78c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9f95940c5281121b93e8ab57fc415ecc6d111d2..c94890647d1bf853b09e24959ec42058c40df186 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57459a44bc051b0393c893e7db3cafadfd50d161..195b503c6394aff02b3af791b0fdc1d4fe86ad11 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3259184f59437dba99b3bdaf2ffc966c72b50514..06b473d9c48a12695a8410efa2b9487b9a1be2d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4c17e06962e275002376afbe248ab9a29c716b6..6f81c977ab81ccee4f08a8532678e3e998b32d29 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9309d6c4ca259f3693747e49b1c0e127d9579fc8..5c8d91575c153af5bca6b0b8b96b9bdd0a2ae6d5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 163f5a6aa80bd5d74183883e28f3a24ffcbfb96f..e3ec149876bbc99b85c2b670b2a87b3f0c5d99c6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22386d7cd4b669a947e39f0f7393d698808f9947..a2cd4a5b2aff0e548045509b6f35876a1c725213 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9954c305a86f2eab08fde3b54e52a094b200f87e..fdde2855485cf9c48a46e3762f09a7aea120f475 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 857575f521f6ad777daffa595787789dc2b02a1e..f5a05d2efa6a998d411f78df271811028950af7c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32011a4615821d0921a1dc3ea7e344a80b792a64..7b93ce0db2ebc8b263e80117d41a6fb75fc0a6a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7fa725d6d040a7ea88d7331b2281054513853bf5..b616c68077056a9d6438173ac838c9685d105ad2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c65a0a637ae85d63033d60d59ba65d3addf9441c..7f42390cd1748410bb01d5b9e7add651b95d9712 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f20bc99b75b154e964a31b9826eab7b7bac481f..65a093b78747bb484ff89da2737b193f83b32dac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c46c7827c1efa8daf02c2b01821abbe30dcee516..7d53242f1190d7984826095d86d84ce0127de276 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85d68c99cc8b8556b427cb0a32d00d0a5115b85b..7058d695ea0efb55557dbafefb9e55c84ce691ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd2f766bb25f1aa94ab590cf26cd8da700d150cc..d214c470052facefa1cc4ab56ef2b2660dacd07c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2959b135eb8f737cf115d62c0facc549a55ca0da..14d4c9fd03b85b7b371c54fe1ae184af5878826b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e88917679bf29fe0f68d65ae5f0d184d17aa127..4072f3cf2ada71a18f54027db9fae415a61ebc69 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aab380f9f51d56687eb349cbe8a1a59b6a983087..9b3f17a1baffd06506b96533c3ba6fa90351d253 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f36f237911823b47df55eb030807a80c19730a7..17a31512da9fa902d76e7b21128edc20f5e27d2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82806b6c1637c0d17f09c6dae278ebf106b1c975..98589c5d31587551dec7f974b051c5e27a93df66 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d1ed6a849d8baba7beb0ff775702271979e5c34..1b9ed1ca9b701582ce0f4fe33556ae7e079263a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37d4206abe511636d898c958a63897ff4aa979bb..122d63d8f4779dc29cd31b991ff3e28553b0d0b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e7e50f8db7c565bcc0a7382fddaa4b49ed5b8cf3..b8bc76912a72f500679b9855ff902d81d6e8f3bf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f66177d07601fd37e2c5ac0a401457416ba10d4..6bed676539c70fdaa6273fe9ed5af146fdbae45e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0869d615574947b360e729f6219a220ec1f05c2a..b31456f03548daa6cac36e413082db6e07c356dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 06020ffab70db94e3ca70e7f3d4c11ac113dcf96..d9747df09b709740ba8882b8236029d88471f156 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 365e77916415d6dcfc22239f4ccaf02382686d59..13692ac6de00ee6ddda51a184b11928fa70c2a44 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0756b64cc21a38d92f34421cb669369bfcb323c0..f0bf4a53023731abedca7af473f4134f9c888a95 100644 (file)
@@ -1,6 +1,6 @@
 //------------------  matrix_vector_faces_common.h  ------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 19c06c213913bef6c050a60785e1c2d060fa80f3..bd5113b38ff0d716ce292bbfa6d73aea58e4f900 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 113b364ee90ff7302086a4b5eb1fc0412e0f6e9f..f0499f39c938215b1edadc7b0f26c8d58f64fb5c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eac682b6cf6bd77073c159ebd0863ff3383e60cf..3de882743e0e02139e9f1d9dd8755a7d60108ca5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 89ff83cbf23b1c07e3d6847ce478b833b86f065e..98ab770ba5b111fa4302ebbcadca1edc81c6a029 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index be2aec835272509fbb81f88552beb04b6539934a..8279c684cebae2d97520f5fa455b591e7bbed83e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dc6c832f7687be1d26de625e8352e09251ec1118..ccfbdec34cdf6a761c13e301b0a4816baf6fa50b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f11f8a78f09120043546117bf175ad742f7d4c9d..34725d48ead9e1cc169079f2be9b44791f5821a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4edbc2de328e42e760d55284cc2a5289b8467613..56d5ccf9e0e5f783fb5264df042e913a4f0d81b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05f492e1dba8bd142a5c567227b7eae9b54be789..87e92544bae5247dafa070690ff308704ee54f06 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 530f9e62de1f9a7b0a8ec93d5f7f2d251a080b46..00065b0d27c32aebc7012a49dcd36e81a584a7d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 64eab7565cc78e361221068dd519d2f1a350ab3f..b5fcd4bc3becb3b2340533caaa6c882932bebfab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 789096ebe9fbdfd7aec8c9f00f2cd339536ccdd3..24ac0f609a377a7a591aad964d2bd0c5eff4bd31 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54ba17b29667b3736a7195716d4d15ff11c779bf..23cc04468ceb4b16330a1f99c5cd40fd3c94b9a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17e48842d0f0972f6688b48e08ad73db647cb5c3..74bcfe25ecd747cd3dc6c82be3e8034a19582884 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2960cb21a9f1384919997217fb23137fdccc564b..fddde48ed10acf481bff988cf1782f6f1ff22af4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 493b25f86bbd9e97361147de993122defd9e4fda..e69e1c4f7a80b4e1e77620bff293570549e52547 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d8adf4e0a3e5203f3d562089824a403ac5d53ec..f024b224963dac5590f4286234eb53601d0d8277 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 302c6e234cd3128651aecd352f60f5ab80974db1..5a9e207d0056c3eef8c1eaa686a776f74525dd8c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea737f3e469bebc7275f4e4ea46b5af5325dbb0c..63efb7f4d2c5e50e6011c53e22117101aa53fcf8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c24f09287ab318a09a32409bf49d7be0d10ee568..001ac71bd68e3e87a63f1b128602e32d546d0cba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e809aacc0fb5edd9d6f14e8c9c409bd758675d8..aea8ab5c045bb60ef63cb4cc090374c04ba525b0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2cbcf4a8fc3699538e2284742ce9641bc94acf51..5d5479275a3cfd333ca6fd23af48d08b14ce2a14 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6ca3b283e2845b5c6e98d1538e6838a2de171a2..3e875651df04c9244d14c9b5eb31c885cf103e56 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed56aa4feacc8cdfc3ab7526af9f710e512cd935..76a6127fde07059d9e9a0930d4b2011accf0d0fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 06e0c69bceb1fc15cdc84d3a15db5cb56129de04..64d48204ceca836363d9e3df3fd6b1755b41f3c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cb419eac41f405bd80834643e25fc2e90840cbd..7a4c44875dd3cf33e60827797f924198035a4997 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db0f7a98ebd3bf83ab7ccfac3efd6e4517ffbb9d..9b70723a723b02123999bca4c7601a1d89a38109 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b48fb53417a474df36650a6e0295541dc2bbcf6f..1cfbc1f07fbecfce5f40d7319da48afbcf112a6f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a617960be70ede0d9dba89f307415d93d3d10e0..c197184bce377fb4f31d5665d181a587e2805a24 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ef13f17285441d5f515dcc11aba2f93479c60f9..0f7bd71a2c30f9283c2273b7aa6cb42418e9fe37 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 41b154fcc0bd3b506d66c04fefc185c854af0cd4..0d0a4043446782cf5942b0dc501e73a9a853d7b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d11ef738645a8fc802c3bad47bbe84b0cb9eec65..11c4947966fda867fbb08895011a9193c08a7bab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7eab9d49f23c62af59ea43c02bf4899fccc05298..5bb7994521ed07fa6a402704f5d2f55d500c6cfa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e117e539f9a6901ab8d61e0260a802291566bd48..ce596651162e94e253ff9069e31099bbb1ac541f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce4431b1b705505e0c79ffb546bab571ab966114..8f3f745a2938304287a30b9c37e3221479d5fe08 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1b477e7116510f67dd78e7f29a2f1e25bceb169f..98f06de90b90529f52e4d41e42e5ba859beb1f57 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 907903ce7cd457b42ae683ddfe39d0bfc4a10377..b0458e2b55bb519bb333f02d6dfcd9163d20f603 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 898d5fa11d059db5de197c5c63950b713672e961..ff348f9e967d197fce9f65188b5d2b3cd4cc48fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a318de8ac8afad2901c304aa75f89edc80d02ea..7525797e4521348d4c325bd1cf411dcc459affbf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 06f227d4336ee6e9461ba1af9df71d08cbb022b7..a59169cba3e7c0dc785837a824828474488d5e35 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b44e6f500389b2612fbf8bdca955ba604475f4fc..d7b9355b294e480287fdf6402b3a85cef50fbc4c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d31224586173b83f8fe7311889c6f952f2642b83..ab642c9ca9ff6349f6f0b4b46ecd4c3d77bcdf08 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a733a284326c3c688259b1ee5fa0ae7ec6f2e10..10ff44421723f062891dbe2156fde39c63b31518 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80501dc589fa2b55e53b3c9d5e4766698d13f637..d5e5f45aaaeb1cc0836e75aa44212efb55908731 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2009 - 2018 by the deal.II authors
+ * Copyright (C) 2009 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 598fba0d58a0badc39c9876ee410d91ef20e24f2..31cc7e42f43cdd54537f17efa1bab6e4555335ca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 264841dac505b9d9ea66ad32ad3d558fb0f1da44..058c69db2bb137b636d69f74bc5dad132e23e099 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 893d3848459dd12ce85ad57358d55b6af3af7d22..1e9dbd0fb0d676d2c87371f83f60eab6788d26a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 246f477274d729326c2a6279417d2999c7f3ca8b..a471c51213544197869b0b9013f55f1d87869830 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5860ff59d9baac94a3e5e02349af0ee8b767d42c..ab1f5b2727ed3f6c929df7067065d1b3fcead5cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d8519f72e934287f0d672ec3203e86e1fa21bfee..db99a6b3019b8520ad43ed30f20d8647a20d5998 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 10380858e48a07f0c852f358d38d391b23a4b67d..e8c4a89ba74359e92ed0be73d06dea1023763d7a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c569864450c4b7884c6177bcd76f1615a3386186..690daafdb8ac07ef98ef38e338aae9d8c48d2e22 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018-2014 by the deal.II authors
+// Copyright (C) 2013 - 2020-2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 874bdcb3413a99acf4f39eb881b9c09b091bfd99..f40a1efef771bbe8f429104887daf2b5328d4795 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9738d36c754709b34a0403967b74176836e06ee6..99aaf78cfd66f3d4ddcc2eaf90f7b5a232e219de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f0c713e73d3d280e6168514ded13bf3c421d255..473d5fb157d16bd702e0c2d6ad0d234ab95bf6fb 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2019 by the deal.II authors
+ * Copyright (C) 2019 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 3d4ed98a43aa274cda3afd1fdfb57abe560e0ba3..b938a217171d14d52c7ee84bb0fc03011b559ab8 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2019 by the deal.II authors
+ * Copyright (C) 2019 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index df07e5e92eb6d06c8cb062f28f46e1f54dd4fed8..20c83345602d0cd60183bb3eea3407e0c0a7715b 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2019 by the deal.II authors
+ * Copyright (C) 2019 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 121af10ece751c4727ee7c96ec3e05fb58d82ab8..464a1b80fe953cf930bffce158d9c85a98669c2d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07e04e6b3b52dc35edbfad75d8ac89d1f025c2b8..04ffe1f12ab3dab3b9b60b671d491fdd47675c05 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2019 by the deal.II authors
+ * Copyright (C) 2019 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 31685bffd1010f4036eeabff767c00b039b28ac3..54ccb3244bf8d4fbd9436edef2ba4ce07331a711 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index b0c5822c5d17530ec3b1611048112353fd28de26..590be1f25364c692b5a5a0173847ced841c5ecb3 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 330e16518a75fce2ba3191d8e18fd501250f6a25..fd5166597f17a5e44e66df03a43e367f14f66816 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index bbba1f986c9df54abc3c359804f71700bf4ae07f..936dc1c70ef8c2f6ba914c2a08fa5cfd04d1e18f 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 05bdd970e7c07e8c487f25ba60fbeaaa69eb46b0..6456c5178082dcf5b1c63f1a99284705a513dd9f 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 0618d509584334265ca7be667482d18a184ef97a..dba49fa217264270695ed786197d7c7cfeff9bf7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4451339f8d84068a2553633f0bb36a1077cf831f..8caaef9c9d3dc6bdee26bdd06f82c5ebef663ee2 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2016 - 2018 by the deal.II authors
+ * Copyright (C) 2016 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 7f882a0a605613b65d75e8f5aea61225fe8b1b60..ccc04eb1f362a5aef104b7f723110ba7c42f046f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8b52acd398e841cc9111dcfe3ce122bc8524821..4053eecbebff7de397c3df40be30d889a45edf54 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 305c0deddf2be4624d58d39ef3e1138feb4fccf0..bdd6110dc5b26441a2338eb583e593d80fed47e0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e5ab0c5127d7206c3ba2f357a210fb2866f715c1..c51f11a9c98aea3e912960dd0cfc379cbb5e5440 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cf48d36f53c5213a97f49ad25e65cbe994a55b4..8a83f72f7af351f964468bb9536cc1407a65d1f8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8cf1ae011fbea4d9a2d2c49165fecbd00d3cb82..2c134206927ca505ec9412486bb8e6626dd1affc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee8419f3450494142458dbaf19a0f0d56b106402..af670fd12ff079e3fd807bef38bcffe2c173d0eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95fb7f724f49792229b3a788960290a73ac56154..3fafaa76d8d749b66a9a83edb4621e36501cb222 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ecc9ee634534090a72e8d4d7c178be728cf86d5..8e83534ff5cc0e7491fb6d787afd986be38b9dbb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b2bd00beae855397d41750bfd14e6c56fb10036..3cd39d4897641788a6c9c7cb384761ed82a73ed6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 34962e1e286d8b69d4ddbb6f3764091577b24a5f..5e1fe3feec0deb52a5f8b1300b15bcc5806f6aa1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bb7fe7e96af427e1d8fcb0593eed0c76deeb07e3..1e64b50d31440edbb80cdff5212d7aa178a78aee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 668bb336c73c65b366dd96400432a80d47d53b1e..e96bd94392afd43372756010126616e21b4c546b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 008bcd76195bf3e6e3a97df02bf037227a346f51..3d60533431e43317e5b341700773da17cbc5fdb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c40cd8c01f42fde58c3d2187ecee9b59115c223..60b546a9d6f930a34631897978cee9a080c4d54d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6b505db63506d04b9d0ce93ccde9d3c755eaee3..0e618679d6f3d2f548ec9506a6ab020f7b73fe69 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c24e170077b160b8222f1fffea2e7855be810248..3f174dc92f972b4d4e0cf513d43d3ef39d902017 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index acb029db640ed27474247f2b8302e4a8465d8c84..cfff72870962f201ad452568f0a11bf035bc2aa9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c5fb884f6d11239e229f6ec94e0a385affd6c18a..e0126fd1d8ddeda7b3b65ff5501573ac13c8e3d5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94b2d8eb8b129689cd8fcc2cb2f3955d2e922cd2..cadddd2d25972d108d58d287bc7e36bfb2f21e7c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 507f0b6b9139398038e7362e0fb058190400f943..e58f6f6de877ccec7ea62dc810a607323982b6c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8d81e63581005e668e5660a043806f09363c2d92..6340718f536a3a3ae045d767aa9e9900be100fbf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6dadf2606a9caba392e14950ea64837211b1d02b..8a2959c5721950723da94342c1128d8c4b22c495 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5179851e9828bc869d1c5a7f3c1d4e33b3bf529..be76ca4e55eea924a64445567beb2a9ecedb8f64 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df6989aca9648dfda95fdf11862a367cde15f681..f56e6aeac9101c8a789ae9ccf9dfb5513632968c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6da8f0092eb41a22a7ab0683073ba7cd294bece..5ce3c3489c4e11dd16d01d94c2abc04775ad41d8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7cb7083be65796798ead03c0ceb3758def64f7db..aafbee017645fea3ed9d5ec4c811ae262dc043ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5444b51c48fd9b99c1855b24cbd196a600d79d5..845e9f4e03bf191e64ebb9504429c984280faf14 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5914d204e29ffe40742ca40492f95ae73ac209af..29c3c09fb8ba01b341086de62736ed76d4a177c3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dbe3a84ed7166e52e0b88d08b28b59e0b6e26792..395114f92b0c8e31b625969eb79e12ba9fce3fe0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f23d9e34256c503430bced7bbe13843a11c22cc0..e2041b8021f75361d4403a5b43a13a88aeff0b20 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d8e051231e2cc0eb4a64989d161d29beef7569e1..5f22054b3fb22c585c1709dbe792a2cb3fa8441b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 19ceaa85078ae65922bce5eafb357f309a624e4c..a0419efe462833630b8f9e3b0466b6b02c315819 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b4a386c40f95d76d1df391e6ddc66e953c6074b..849a1e50bf48aca094e24333a5292ecabc89ef95 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe592fbf3c81379fa470f5d9c20f5f4f1f00edec..1e1c24ef8537b5c7ce768b481ba8e6390617fa39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4991bf1781d014c0117d859dff5a1417edf92331..debf9e86c4d1ff936e7b0e0bfe9fbda2aa631bbd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c1f573dac5c59ada192f91e0467c6746937d93d..6e31fe9ce8fc1d86acc6bc6e58809db048754c86 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74b7d795826fc08569cb6b243759dbe5db45c1e7..4db29af69388bf6433d0dc8cba3a59f1614f0b88 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18222de8430e786b27e0d6bbe647e01b7691c845..894ad6300f4a05600124c128ae3ff57fc764a03f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 04581bbe7b193fb68e6244b09743c74d8b5b49ef..7e8571e9b218ed285b823ea38048ad32014498b5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c3055ac45048780ffff52d0261f6942b744d9b60..123ecbb4cb2dcfef699e1dc1c2067676199ec8c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cfd2159fcbf25ad5844c4d62a4e386774577ef91..b7dec8c2677d3599c4397c75acc2462907ef570d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 102f239449e1f9ff59c8dd6d2071897ca5a4feaa..822777d806080a27c2cf142b421195189b1237c6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe894ae7195d6a8723fd63e68422317d3b6aa10b..abb8892987c2ae8eb0d51b577826b237e514e478 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 89a4f744c6ad7aeb10e4b7bc0b7675920c82eb1c..31696ec8cc9e8b2bed8b22a3a037cb29fc886258 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 270ec0607074dd5d0096cd3307d526604ecd1bea..9b8ab44f1f22d69b8688f06835422486bf1c75a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ae59a75e4d0868c491a551ad77de31755af6e36..e3b570371fb98fbf381e0f130cafdc7d1ed2cb20 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd3da607af23a26fd4300c1c1b5bb112272fd364..8c5247a0a474a601007dc633a6f9b5552e59de7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ccc3ff233e6f903eeb505eb966c8d3bb61bcd3a..8ba227f22b4b2755dfbcd67c1fb2f0855510ef5d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4b4a1a54db6345a00786baf5e4472be12b0aab6..c4c769a631e5d40b1157ed3708528dd67f020b18 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38138497ce32989e6c99150f3dc2286f8bf32414..e974de1e06a5aacd4011ad2a4548cccdd08e590f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82ba4137f0c5b6a167c6e08a9ae8a3be4571963c..dabc4a0fd01565b659243a51c2d503b7a8c92610 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bad115382e671e087645e9e8d8e71b28483a9da0..c443ee7cdbf5eba36a6549036bc45059050148df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d111b0f91d90ab16836d5106cf2be0344a9911d..51ed913416ff75409bae82a2deb98dcd7fdb0f96 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6f59092c5c7b0fd268a02d685a5e4f93f345165c..84020fa76bbd848a8d5d15e0ebd6ab955b2e365e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0eda24a1d321dc06d97548f58b0148bc8f93b83..9191e623968960ffa64b389e6e7ada2ab6387495 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18af295ef2827c5f8b383f0b28da0338126ce54a..841e10cbe2a58190ccb071c25f8ec3747f23c8b1 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2018 by the deal.II authors
+ * Copyright (C) 2008 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index c59943bd3d3fd0d970a03457b3e6dc048bcad9cd..092e4df458ce120cc2d9bd318bd11baf551259f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 27d5897ec7302d413ddf34d753fbef5a25600757..85930faed00259f1ed618299843b206baed51e13 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b52d920f8abc2c5504c252ff11cb9b2512253549..63db8eac75afb086847d3220d594b448f81e63c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5cd4dec1a8ef14a91d3410482c849d0ca0632b0..9a00003822d1837789d501fd4e8bda0cb2dc0921 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 489b8f3542429d7e645c956ed1e995be354fff3d..75c78b97a93a9952295bf22d504c725f2f34ccf9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b2d7c5e39b3651ddcb8fa3fef30b5a83ab29163..75b48cecbe71647bbf99b7e3b5e009350b5dbc9c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63b7a64e50ac782a885ab8fedc7e20eccac904d8..2e9243935717554ae259265f603578e398acdfc5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0779ce4478a97bb73a15fdf4c22614f5e039ee18..3597c264a8809ec86a3bd0ee27b17df3560a9a4a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 602704b565a857275b4d99b2fe85dc2a804e4cf7..7a4d1c0899993e9a3d944ce78bb3003bc28f3677 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2af6c4506dafea3f8e4a5313aa5e16b920f44da8..828a602d5e733595cb47363e7393ea467aec5be7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0326d0f51c4a80cfbe0f8ce74d576089810cb9c6..2ad23eddef6b25f18406726575d9546295b6bd11 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index afa0482adc17e38aed748af288bd1feed43bd526..a70c41554f6f2ba444a558bf6ff88ec1db51723c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 62e95eafd6f6c449a615acbfe9faf020cb7fa7f0..614fd272179a455f507fc8778cdc57607fe23e9b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e3aa7f5c252848af164c7b16291389f6b700f63..2f908c1e43e37c72c862782b2139687440606ff9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60f058ecd26fa4a654775fb19ccd287d30598078..4583955c4cf00e13d1af249c1a20a30254fac113 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2019 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b07650c0d17674ffe02d8ccefe08b1c3975e69e..4ea64c7a9dcb7a4bd061fcb2d6a5500fe643076d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9606009b5f89fa034351daa1457cc59739b4ad44..4f127841a61fe56b76b460a0dbb2d7add0a5a8a8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b7aaa5bb3be8783cea36c5177ee7745f279c0880..4977383efa7ea5b98eb89e422bf8c0a5544e3c6c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6dbe9c87f03018d3cf9cab04cc8c3d3be18a074..d4dd2c4f586782da355d7360eaf04744e17dc3f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 78cd0dd600dc77ee3d42114931787aecf50b3dcf..d5ce0b59d47b65e6c89355db87d1721d539c0024 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 639b51091fc0f93547914904970389e89899fcb8..1a9748539d391e75d64925fd745c2bfa4233ab97 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fdb1dc8f7ed24df2a6704b8f05cd389d07d5fdc..2b2c7a815d8adb9df70f33514dec48f8dd3c22df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50d795b08e1de39df5196f2da9c983f1f6c4ba79..d0304324cedf4e4d5079ed34254725a99e6bc074 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91b089b3a7ddf81d4cbd52c36bccb448a8712288..56bc3ca7f3e9d5d2267fe51e2a77ebb865cb8000 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f22fe23dfcd91330bfeb1d1386c4b309119860ca..e6051b37f87e212637abca7d1629a4404b57ed99 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6fab1533c361621f8453247abe41f9013c6a1471..5cd689f583d5fad9ad031a2fc0004e124698a318 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2019 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e98eee8f7addddf3cbdb09b584a92cc435f82334..1276ce26b5a01669f333479d35bc96c9fbaceaef 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2019 by the deal.II authors
+ * Copyright (C) 2008 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index a7c0cb4240ec69162a42c7ecaba229afc53fa594..e379076a2b8f71c6d93e5b104364153ee6979848 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2019 by the deal.II authors
+ * Copyright (C) 2008 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 56cd78cfba78346dda67a07abf9b1dcbf2482d33..b44a967ca79dfe0dea6e6af2cae0283770bdc138 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2008 - 2019 by the deal.II authors
+ * Copyright (C) 2008 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 68b88ffb21fe9ea0663906fb36f7bb3eb428bbc6..23294cc3494b10fe0aeb68c0ce5b550057fa6bba 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2017 - 2018 by the deal.II authors
+ * Copyright (C) 2017 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 5698c5172181ea5536e8420c45cca61294ce4d9c..7752bdce944ea3a4d5467529f2f1bef989131610 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 638526a31ec80cfdfe97421a6ec08330d31ce68f..47fe609db7ef956c01e8f17a5726a37a30160f44 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2018 - 2019 by the deal.II authors
+ * Copyright (C) 2018 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index cf875044af8ebdc3dc7a6009049654dc80360283..322ba6b3387622ac2c8968d58d957835ab8b1db5 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2006 - 2018 by the deal.II authors
+ * Copyright (C) 2006 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 0a9230d0ea5c8bd97e3d78064fa236000f44cca9..f50a3790387b0e68df6bd37854d1da2cf67e1ff3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f195ed9aa4fcd9adf5d1051e10bc3e8a74625ab..f4eaca18bf085c0d512449c6bed82dde2c0e2694 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 35ef37b0bab7b437ab6660cdb85bb89659b28746..cc575c752affc9a9eead25fcb92dd36661e0e822 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91b2922f95be647fafb8129c835fd8a45b063b2c..ea14dd0e27ae1fff5e618c5c05dafe341245f09c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce3f2c7f8840e072754056c8ef42e9f51124bde1..962888f4c4f753e1193277cac6b9149b323b98b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74bf4b8d3a286ff2c31115bb06c8da5721cebd8c..df7651af779fe6dddb3d717c748906a2f80e585a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2824c55a9141bfd709ff09431565510aad16248f..213c03d4f6b607e3ef9704243c19f17a47d7299e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca75650a3b51b0a4660ae88a8b30e77c797fc749..8fa4708c867bbaaf3ba532d6bbfe5fe9a72efe94 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6bc309ce24342155d4abaad63904a92d1baf23d1..0eb426ebae0cb075bdd8659c83834f34ec8b1794 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57da69cd18ac61c75e333d0c85e6b6de7253eadd..aeadc25631179f089093f0bba21fd500fd8314c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e941d645661597828cf0038bb8ede365f3462079..0a57eb7b38246f69fd01576f33b42253b27718d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fb467fb2a49923172aab0063653e78be799af352..518ef4e6194b3dc751d71fe8671eed28087d40d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bf82ad9e9c3f0233349d84761517b239ce402a7e..d26a7e06381cce532baeade4d73bfb2b792eab8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aae1916677aff6bcc8ec88d006d558e61a1a26bd..ae04f8dc6ea90284e581f971cfc0a9c2feb5e4a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca3068cae10160d6bd834ae2b609a8a4e26713fc..140359098975e436b0c1190f5b5b3351b068fbc9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index caf9ebf8e408b89bcd92db7c9f5ee3bc6bf7300c..a20596981b3bbcfeafd7bbc0c832930840cb8acd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 580f05c9bdbf1ed1c5aa20d786d97f581d2c31f4..8e39b5bfecf3a2c46530b791935b7d8299267a8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42427dc5d1ee59df1a89453e847d36d1f6dc4604..3a28e687d08d5ccbfdd0508fde6191f6f8eb3be8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f93e50564d68fb9815bb224ded594521eec34ad0..b8a0e0e316ff0dad8f099285c48ab67f52157e87 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e866ee5707aa7c1dc6c89c2082096e3507c2e196..4562050e787bad0483582047afda01f5bc028142 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a61d845ad6db2ff35398da5017b7bf9d1d34746d..c48f5cf093a8cbb8aafd7c51e94aaa9791575ada 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 421b69a7a2e5ac3555c5595d88c8031ab38387a8..7c028dfeb19a5a93cbcfe4c133f20b2ea9c30544 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85e669cf458953aba393de6dd77e4f50653f5ecf..d25fc17ccf4de9cfc414212679a99a5af78fba45 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 245b86e4960eb9ae1ed0bab9061c3e425f3473bc..8a6b31d3fc590148073a30cece14945e5e214a28 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ee0de28f3512bc3a2379d516b7b62f88c28f2bd..cbda9619ce35fe7713575708609a5ac51c4bef8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c34f96614e7d7625151f6ce73ed0bb65c319f56c..e731775d19cef73aaa414d9450e6241e865c39c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8e4cf0c0a7399a329cba9a69c68ea34a27aa185b..f4d44bb1c4de5527028757fd433283eeb9f54e5b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4e33242445775b95361d0ec292ffb5ae3b67158..ccde3a6fed12f2f28b8afdcfbe0f80fb7917d675 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a35ba789c86acd208d720e7d481b8b01ea01549c..add4762bbfd7176760e4fc70119e37888206c662 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bad2ded69dd431b9dda828dd9651caec7ce6d8cb..6f21de0a6adf6ce718673688f04d6d2aa0f6fea1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84dc23683ae0b378d61ca2a32c2acd18d0b0cc7e..2dde52358ad8d670f6a9c18a537a550cd76a52fc 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2006 - 2018 by the deal.II authors
+ * Copyright (C) 2006 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 94cb229b4eb7860c0d882564dc1f4f0014044c33..e8b6f73157639cc9733fd5849a1f8de9ba10a4c7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c804c8b8153dea83f606bfd5e91c01f877b39ec7..61b24c402d66f5c21ca449cb75f7b44063456bc2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a79583351d7af67ca1c097fc803b9c672c8af6f..1165f8251d9693fad61dac14958d0b6b9d8e0abb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03b09adb04448306f9e63bcc168e89d12e0496a7..64ab84b6a826a571e56732f839af3e444637a9b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd338351ac5e4d8565d37346cf9ce5c77fc2abb5..02639f8fc7d9efe0a0cc1603ab360dc2f363f459 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e9a43855ecd3cb3b36e71b4fee2b8b8aa139374..bef29b0ea646569ad80465f5f118e9201fd8f7ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 75ae2a1d37fa8e90485fd909a077309d60649ec0..aa0d18af5c274ccf154eb5431495c9b1497dd0dd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a93544dcb7a035ab88537194173bcaf8482687db..6dbec7b259abd4b5d06cd3c27b8fb82d4076a8e1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 01852a460301e17b9d34090486d0118fdbebbd8a..716cf1af4f0e067a6e5233e3ec51d4b66019a205 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2dc079cace3b0d5b36fe52bf43aaab9e49741b03..d1f46435ed6440e23c365ac145652042ab953767 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4b2c690bc2990b5ac28a439f51039584d478fb27..d11703d2593f6ed30f262ba102a9cfaa781be042 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a8b1fde1b4081d43b4bfc05ca404da1fffc5688f..ac5d2ef5ab2b7ae3de4bcea5149f9a0d03070cc4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94acd75e324eefde7cc6289f6e0d576711d3d312..06187ad09d96d8045be3c9da4dc00c961ed0e96e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 371cec7fb7317a1d4ac302b1dc10b7bf153b644d..957a1fec17a372c477a5b354909681f6a22b3ff6 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2016 - 2018 by the deal.II authors
+ * Copyright (C) 2016 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index af7bc613c1304302b549fd881bff39be33907628..8624ac3c392c1c086753b4ce81bf267695baacbd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d04e337907dac19653059e5ab3e0729c33f70a3..558853b49b2a5dfce46ff436039abe7cfc5c1c72 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 56992dc5c828d1c7b73eb3aca329df420152b1e0..ca7c5da2a8d5cc4a96d31a8e1d6256030651434f 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2016 - 2018 by the deal.II authors
+ * Copyright (C) 2016 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index c3ee22081bb9bc42d002b66e75333f3d0dcf9d97..3cf902a492c0366b94b54c0e05be43954a60b30f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2016 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07ece8ee4e152cd87227ecd8582d5752cf502480..72d0e2350692f929cb85adc68c6e04025ad964d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2016 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9d3362f3bb5aa2bf2c0879f32163023e20b9696..2737d26a35113d437ce10940db9e82e4f869608a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2016 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3378e79f0d474de1a57aaf203d493104172312c3..c02bbee97743db19197a1fa71c2ab368a489a94f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2016 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3149084cfbbcb56dccb6df7d23f1af953c080087..497b9f8d32e51acc6056fb86426c8235d303d840 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2016 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 507f8671c76b8b002ee5205d85c3c1fa2c012efa..a44c0b93ebb4b2eed229c53d2a8148537498f718 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c5c06ce8158bc187589aa43d1e513f42134f64b8..4b88e7900a38a10f4763cb4e3343c65050149924 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce8a8e8766d20f275bbb8f9011092fb3cc45addb..bddb63a5ae7841e97049641d44ce30bf170fc1e7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 156030459d640a096e8ecc89a903f9457821ea83..8b7a64ce442102c8d4128887d159476f8afa64a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 508a5aa817e80d878c86515df513c9b11dbc8170..91ca55d24b13e524708aa1f3456cc5e2aa7019ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1cce3de6a98c0a2d35f1d31bc7d86612aae7fdd8..bcfa26b24770603a390163644ec539dc8d7c8abf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4cd07a746caf0f47fab579699acea7a8825fa89d..71546bf2832bb186829b9d1fcb9af5fcd959bd1b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aed52fb3ef828b497c3d32b9b9fd6f7d2892166a..80b35202f7cdc8628aa634e01ca99f35e23a292a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3a4a4da86c7abdedc2422e670c36366a4305195..1ac6ebbbefee511bbe0f8d41b8157354f25d04d0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 67aa226df200e5499f31576ba39da22835ce7aa9..0a70e6bc6c20f86bb1d25d0983fbe31e12878d64 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0fc89b5c6528a3cb83a3d0a5ed01c6a1063f3ce..2c1bd0a1d76a0bb914cd2b41d11be52d3f99f538 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a3589148d4101b428261b60c501bffa1a021022a..22df24bf8d9eeb3eed03130c5c0d1520f1ac8c04 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cd051790e1ecf44e9d1a935d12a409345bc5cc0..e3b81fa9a05618baba6d9b4b3f3fe60ffa565041 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d89da1bb9166a09552cfb32c399c15f5e29d2de0..3b485bcc4600a0ab6028d3aed740388ff9de6d82 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a7a99bac9d209488dfbd81324487199f0c9683a..af8efc35ebbbbcee3b8cf6ba1d3e38af050b3469 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3b9809d749ca8e3392188cf5d82df82be1b0a9f4..9c78b5efff41289c3feca314c85c65a847265b3c 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2003 - 2018 by the deal.II authors
+ * Copyright (C) 2003 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 1136ad4598c7c6bf192a78f8a2db72c4805e855d..d13e0240e977e922665728680fd99b8bd54416d0 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2016 - 2018 by the deal.II authors
+ * Copyright (C) 2016 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 3a8212cb0bd5e44478e38f5a0b639c8462d63fdc..14c0d02d775409cbf6c835db02e365bb4783ebd4 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2003 - 2018 by the deal.II authors
+ * Copyright (C) 2003 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 1f56b6cdeb2848b84612850a68eac504681d1a38..5fc76f023cdad91c0dc747502bf0326e3b725c19 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2003 - 2019 by the deal.II authors
+ * Copyright (C) 2003 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 995d80468d2977a62e4fe41380b2e377953aa251..74bed1ed7e6b4aba4dd738dfd1e27007fc410a76 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b12d45e237f9f83d03e1c80d6146c257a503c865..09bdb58b33fdc0f5c9fd3924ea36aceb4ed0c2ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a5e9a968c793e7a7f89ce3673225e441994a0197..aab173d8fd6c5d8e0f90bd18992f0fe418ea0adf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc52a9de588ac7401d0797ba13883f561654ead5..bc2032d6c547bbc80e4187a3abf7e07196d70e23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a6aede4a852ee388c41d63fe3a95b5f4cbdc7c0e..f22e5c86384a6ff007efc4e79d0087a47764b1a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fb4db17f3d86beb761c33195404027c0b6d0e02d..0ae498d4c9dcdf4e13dd83c3f4325e30ee55f89e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e21f3e0865d38a7a985dff518d4ba5256eea722..df241c12deac9cde408be7fd69b72c1d7c098ad5 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2016 - 2018 by the deal.II authors
+ * Copyright (C) 2016 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 46142bedce050f4672286629804e8fdff78b0396..87dfae1b72333688646baf9b2dbb4dac6f41470a 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2003 - 2018 by the deal.II authors
+ * Copyright (C) 2003 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 12a96dda6e71d644230e142ecded586ed09153fd..32b048fffa60450075098e0ba30a1db9db594ad7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57be7fdf0a3240adcb5ac3f6cda3cd9d1052e141..e74411e3101a2403375f2858eb119f9021a5609a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 757d89676dc17456f766c16bd99f95b77827aa06..bd9b8411c62b69855cbc2340fc3e43b67806c49d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f777882ffed5070431b9bf230c800bdb247e04e7..18dcaaf26035c3a1b42a6bd0f7a6a38ef89a53ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 118b19d6413c560a1f8a91bb047e5c1e413e2006..7dd1e53f03d9ec29d6e5e22245b401dacf9a3412 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb6a1366bf925578fb9524ee4cd3e79cf87fe375..83f535626722865729ee625576ddd081292ea473 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4cdaaf52bd9ce41fe5bb070ab84fc667f49d45c..45116064f1817aa6a36e3e33ecce9776680638d3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 87464ef19e1368298b6978e87c3fd0e2e319a274..1bcc426558f153a54d90afc6557c0a3b1bffcca1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2962b92a1d0d8e5136b0dc2286a2c80599a5b14..3264d1adcb337ed7834f15290996db12fa62899f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd5c25227dd83830f0c0fcaf6d596e1d00bbbd09..f3d126c59369a3f0dff2e24870617efa67b162c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0fdc7ae4dbd7cb981c83e6244bd356837d4737b..bc013f198fc10aaab8be69c6e02ba7f499611dcf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6cf3843aaf13338b080db14ba964c1ffd11b3c10..5387acc103812de8b7a54ad509d8739c61750595 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4e7f5e2041d824bcafb3c7133f05a3c353043ef2..80bc808435f5f0e427e98bfe56759e23508b37a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d782c8e3081e652991582138b05b502fa8284d1..401f463a0ec6f575b27c180f75c78082210c33e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c8369395f4bd6a2f4dd715c986535befc861ba2..46bb7b84945c46fc1665edf045d096f037a0543c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4ec1f7e5045ef7fc349fff461defcead28f95b72..ac97c73bb42fe3ade3e49453e1393e31040f836a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 344a1aee68e5cd22e406f4c31273dc96e91611e9..562e5a1791613591d2f198f1190a5b058b188430 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4410881eb3b1a3ac8183c1f4d4be9e145b8c4af3..29292636d0f899eb00c063c50bbba4e77d7aedab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9859db1e6302dbcb371f6cb9447b61d1c5993454..0cdeea5b7e1261083b4ea72ce3da7525a9de4f5b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 18b33e98a925e4e33115fd8553a285b93da1fbb0..19e0c46c3f77cb129b4600080c109b916a9a6c6e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba94fa9eda803de329d23c51dd21bb66178e5b31..4ce6ae233072e9b847d2341f6d88fca4c599103c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7b462d80c21ed50385835816bcb25c0b6060a2d7..1acb2c61dfb1c0ceaa9fb0c3416be34e616db4f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c459db1fb40d3ad9752a1710b8bbcd754e868f2b..9f56af9fd1437c4eb63fd475efc30647930da628 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17b1fce6643730924a8ff25b5c77471bd5691b9d..d042a5288cbe9780151f806f30a240dc29cecb21 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd1e39bc119d44c37fb505f8e2efb304b5c711f3..c3954e918d45249a41a1312845d8bed8c350f37d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e428f0dfebfb2a231d03cc28731075a3fd9e10ce..844eb7d78f62769ba9c6fda71814f38244f9aea4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0c0f465723db25e6c7199e5e8f7bee84fcc5a2c..39d1451919552f539c04833903e090c573a1d957 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc05a0ebe09a65593f882d25f6905ed8300606ef..044bbd9ce9d0857093d9c0ed1dc88b6ced16b33f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e18187c877ee8fd9258eb2095012d89774572f0..d71b5a4316d1743f8249c99ed3328f5f5fa7a6c0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df2ce18aa07caee15514732f070fc4e34262b030..c4b32870c3a4cd097c60d61076944e442e42390d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a7be5bfa6cbfc70828f152a09839c199e7409d6..c71ea7e2527f79ae46e0ba2b19f6cf39d75a0ba3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3edf984e5426bbe830fec2a3da7b217fad81b28..8464bccc7ad84d82b67486fb040025970d8c0346 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d530fb2280d7d18c85dec85c1c70864dbc065463..528f92357cf1b3824e01b00ea071f552b35bfb63 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8b9be12867b2ee70409f5ab1b3126a21ef532322..70d05e2d9978b2151cba2ff9c8eba161dc6e3004 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bff290d565735e12098e7137464946e723b69fcb..cd385a2fb3fb12e46b6bb045c711054603ed1bdc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07173a67b934348185df0c22c871226efab05ff7..1f4237bb28f75fcff425025b234aeea083fc5e7b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 122a6904f2ae46e673094e97f3ceeaca61b089e0..e85c3db6063b169c81d966309b8824cc3d77d44f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ac2ae17d70fbd919cde32ef1704ab564624104c0..1ba7efec908e4ae5dc70845d9977dad99e94b400 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e5651e383314400aa3a231469f3102f1d449f31f..8088753f34abf078ffae98e848082611f15f3ab5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3fd282b69dd87d8531cb94b7b64d6606509ef9f0..6ff42903efdd8bf34aea40a75de4c6b3d9e02748 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2900a8ce31dad46a3d40163b7ec518daed156ec..51df602298373879a8119f03326aab17cad4f0d2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df6f6b365db4cb5041e33c4948873a48a58e2618..1a640522fd881d89fed8fc1fe0cf22ae2183d602 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b9103862f70ed268991c2fb559d6d6bea2849299..6bdb0c678425cca96981c9a7c9be57c85ddccb18 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8ea79d0a34ff25d58ce226920fb80589b09be16..a41074a63b0841dd7420159a5b6a3a542cd41748 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 20492c9d99d6d73df71c43264e1aaa00fcd8b88e..e52294f7415f0cd5fc2463e8b72a8c4cba3ab007 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03fe680f31fa0cfcad21a6b09ed3cfde3303a82f..8c632205e5e5c01e01782f021187c07466f40667 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 01417f69eba2e1b3e7f00a00064355a751e01961..e7d158d03656bfa79392efd5f8dce5f81212a89f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ce345c4b5e44caf5ffb9c856c5ee4d2175c7fef5..69d50a63db60d30f470b1f6a2551d9fbad98c821 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 082d638f4aa61c08639e0e92b420012b9a789a79..aaac8ac625bf06b28ff1fa916f4b07915ebd5839 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b6b765acf530443b85c51cf46d4c9badedded88..12c868ae405e7ab04f4407a32b2ab8e16e1cf001 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2f2d230343fa4274a5e76a072d0f5f3fe05326a..ce450f11c884c37016e2e86b1c6285fd437e9447 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96058028f6ecb07c4b9304b43c03f0d84ed1c226..545f1c03c994954d9db1441aa2e38aae8c87ae7d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d2fd4dbcd0740e18917d1a81545a214edfc8468f..bd5916a00ada9e8f64ce558befb768a9c3fd5c1b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 08b0561c2afbe08bbdd2ed5d867a11ac90a1a8f0..ba769d12c0a8dc236c65af94f24c2cbef4cd56ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3633cdbb492046700fd1dacb4bc90673dba6ef7..34abede9d23f35e2d364ad6efcb61f8826c030a3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5659b788998bbfb035ae35fcefc2f8b1ce6b3849..2db18cbcf6377ab046cd266b1e21f6d026e6ef9d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a8883fe586929bf8ed30e7e7d25cda480293a505..9704efca19cbcb57e1aeb315f33901f7b9afc706 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aea7120d535d43035e9b7355b5bf92cc6a9f0abd..b26bfd852c5a55d733f3ba5ff751668b60d7d58d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e8867831e3c6891f52ec9560ce9e6c306c6ae1b7..b11211ea6e88b6ecf4d13824c742bca851d08197 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e83713e44d29c634ab77986adce008741df9791..bc2dc193bbf00d3ab12a2e6562510727607c6368 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07eef84346725d7668593372ca7dbd620fa54baa..d148a13835742266092635df813cb2de1c021591 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68d7f10a62cdf3d489afee064433fc399c34766e..e93f9ec190fa8eaf060a735640ad599acf83a32c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3e2c3bfec807f07ee049048b63bab24e22b8b874..964f68ceb37984186e9a4a519a2f04611ba60162 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e4c0d6cdd34158cefe77cbaec2bbf064bcd4a33..96e275261c675a94bb16549f069e77ec51bbc5a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fb0b1c65e09ec63c5b52af6d18cb1944b5e15c1..dcd819820f23ff1a901462652ea739e16b298e45 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 38447b9e7e0ea83e09386eba86b3dd83082c8256..462d302200c995bbea21f2212fae05578de01c05 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index acfc2eed144dde1de9a7eb830393985488f0ec24..6ce3e2e65b1d9f5f7935e69d183a7494a429078c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b83882376ea5a2798057bc2606a0be972c9f18f4..9cb21c5e721e3b1d892f996f2aac04926d7031d3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2019 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c9db07fd58487efbacfe1ac50211548f75e13d1..503cfca1543e30526aa937531b54d3b0e4105408 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf765609f7bd8b24b65d637339f577a172b68720..4cdd64eee97acde0c30861ba9d6a8b84a4c3b2b3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 111fcb259d12af2ff1a38f6470d2c83e1dfde0bc..14fe900453be97224bf5057b404086cb2ba66dfc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c6427945efbe418c4eb60d210f7852fc45c9a21..3cba01fe7b7bd699853b5d4ee8abe557b66fd3e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e4ff5e336d9f5142f94727055bc5e46a284825f3..c6ca15822f90b9c1ab8fe1b9d4762f8072140e5f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e31506a7ee93c90c6e277f98a0b241c327a1e29f..183e8a5fbac39ba27969ecda4addb1559d3ad33d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a179144937e48b86b815a98a3a946084a7ac1472..ba8ad3d45f26f1187d301542012ae50c725c34f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a8c089473d1146c3cf749406823ba5ba3415c0c3..fa3c53f59b7ad164bce74f0c217a3acd1deb46dd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d53170294e4d390ce406eb2dbf484121c490afe..c755b20b60534e226e441227df481cf682cf12e5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5618d9efda434bccd483c1f47d95b3ec67492de0..f5e07cfccd2ad8a2097cccc6f0267e54bc29ab8a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c9d8291f188d67b53692875de1faf1226aedf20..f6930314836d62cdbcf0e4419255657eb01771d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2012 - 2018 by the deal.II authors
+// Copyright (C) 2012 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 80d3561c9cba22906aed78fdac3996240b0b9a1d..1baffc6952ba4c91477450946f614090197f9448 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 484572a1e723d382c23bf0498b74c23a576b9e7b..177bda2e74ff9377747c2208c9fcc071d03d5e78 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d24b7668a6f8418efe58d9fb67c44470e49ce29a..ff0f5005c86124f9069a36d90f0a116b95309218 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9e34476566046ca09a085d4f8882165b399b441c..f681dbeb47ff6314d9a3a70613241714578ab7a7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ad197eab6c077ef0ae1089b86ac0dc825b2e201..1b14b1ecc2f14a8b495bd73dc07065a1ac548588 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2439ef92db5ea9d5003b6d4755278b2a5f5042dc..ac4b353ac911ae473d3d39bbd1d4b69550682ea5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab8cdb5b7ff32422306f881d00fff4140305fee1..1e3922ccdfecf2901fa3c0c12d03dd9dcd7b0383 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d38898b8bf6033d6d9a0af783df34ac1aa9f63a..72a103b05a41159d423a79a09f0b53dcda04c2f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 86142cef4fb3b46e1bcbb9170d38e7b11f2b348e..a1bb7f2916d280f7596dfefea166c0206ad2b665 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8bc524d1cb4d607c35a213404219cf34260bff03..744b3092b8284e76972a1260f6396a3cc599a9ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f158c05b4b658c1f7807674cdca382bb08540eb..580d73b13b750275dd9967e03f025e620d061e70 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d3478fcad8d6829aeafd641de04a78f216e6c74..c0d0631c0df932ae8fc5ec3b0c88a6265a312493 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e492934638942f7bc067fb397fbe301fa2b7bdf..e47b4a380c1667c441631fc4e100f025d005fcd1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f7c34e4acd6ed69a84deb6649edce7bea7d85b32..462f65cdbef6f381f386f8274f053025af980874 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1c290b3f7be02c93547e33173b1b77fc0befc1e6..73734a52fc247abe3d487621189ad7f23e309146 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b97bb70a91ad1beeefd8a0c52505b454908dd1a..1dbe2027a04b46123816787fbea1f8894ca2e796 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 346bd5cfe29e2ed7bba9b8b7da16b0f9d0d29a80..307c5da8fe0b3f6618ac836a03928247fdc365a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e358b45c62933eaf823e29ed17d47f751c67f7d..5d2c94ea1d888df2173914114aa3a0f906ff0a97 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d958f130c53bf001c161f217d0a5c452c7d287bd..ab442f48a60eac765e53df672ab828e043981991 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b2db1b9c25c484d97691adc042f171aeed70eefb..75c841eeae9204825cdbe3d927c6c3c553f992f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9aa43ed9ec02112327a285c0f9a64df4c091063e..301a9265ded900342f6703b7b7aff351adf111b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2ab69a3df7359c1041c7cca1f0388b8c232f391b..fb7e0093c1387c0d57ee2d39e6d250fe39417538 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d876e3684b9f8b6d5397ebca8037ed1b1311bf52..1bc44f63d667f390b120289d29c5a2ab5c3c78a3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 19ddfde26afe3ed9660760db9a91e8a8cf116c0d..b5b0bdad4a678c533a09104cc761582696ee25ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f9a0dc2cb39afe8455ee92fc71bd36a2bedd8ba..4c9cd20b537f1537f1116b94d4f10e8cda951e1e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68423514a6690d3248b2ca172c64d901563846ec..cfe02ddf7b30343570b1723acca0b56bdb9faa23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f3a685d160776d16b59f8b0cd95a515102f5409..4639c3de6a17749c7b440ea053b2e9ebf1714cd1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index af8156ba3a8cf93f66894434977e7bf1066bfba2..f4a0ed0213dbd88b81920e4bd42e9bcbd9ece7de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17444fb802f0b7b94df67f928c35b4ea72153e54..fb9d89011b99218b1ab5ccc48235bfbe59c8400c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2007 - 2018 by the deal.II authors
+// Copyright (C) 2007 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f47018de69515502d92a4b32898e721dbae7ba83..aa508f3b9b955adbbccd8d337794aeff48906d01 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 194d5343f7119810dd0a1c50515dda158e9bd9ea..8c0ad5d4ab483b7ba53fe99cfc8ef4bd1f647411 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff9d87afded2ff2ff86575ec8e314ad2e88e396e..fe355439119ff09ef6239a0b7edc2c5e5bbefb7e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1619f0035868f2689955f981f92da241346b587..f326ea273e10b7f5e026a6376d8e89b1356af7b3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2019 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c8e804075ddb24193b9a6d344eeb9cf9c1d0ef2..eb06a21482338cd54d5024591800dc2234601748 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d5e7a64ac7f2e3749e2e0f4d86a530472d75d7e..b7286607cb6395409c424fec8d4e370164bb9f67 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f80ebe13a66c860bf00fa6683bfc549ea696d1f5..6958c7b5c60aab45785dde2f6776a4000b007973 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b03a9557785cab3a8a3bd4adc0ff179d93d04343..35632d5a19899bf66c0a6f027e2bdacd1ae47838 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6015069d524fd73ea086f82704e153ce2411188..b1a04616a8c0cff68e3864e77658304de6eb8b7f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index db05ad0595e8b1f5cbd436cb1c5e050deddf873f..b9d5eba673f32a736293e52430f1cd6bc49796ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60e6eb40517f3f2b4820a45a2c960c7b2af7e04f..40f5dc8180a9ef13f05de2399d3a8addc32a2dc2 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 29875f92f3ab39a8468d319864b2fbe11c4b0df0..21f625437a3f59cef7e9f4958a333af2e21af12f 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 368d00d26f13cb968bdc3ee5d0327d74eb5375f2..5377566fc98d9fac7c32237c69394461da4ee221 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 12fbc95c311fbda73d6182c03640e9060f0c9514..08aa8fc7253ebbe185883496b372ba01d46f04ae 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index fd63d9cda0e0ad4ee6dc16dd5e46754b864ca7d3..d0672d37794d23d3972b4e494b90a4ef9c9a09e6 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index c5c6ad07e3047215211e56c3c7b7ffc4b87b3d21..588944e3bfd7421c5e88f636e7cd65d1cfbd24ea 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 47b6fe9c7a098a62d7fdbb5057836556181220f5..9c7fbe8320c02865ac01084a661111b9e0e5e4d8 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 844caec2a0e08b61e6c31eeb671403c8ea22252f..66da8e0fedafe7f79872b4b61fb24aa2b31b85ca 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 4daef1793c346a7424cfdbd5bcfbfe845d4be226..c328ef887a68ec377ee3b6b4da8154bcc28a310c 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 8da838b78ac486372e61d844661245db36b80dab..42eb686cdf2a0007981e85f9f56a5596b5cd0c29 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 1813a8f1324f4d817a833a4e6e021c7f2e208d1d..dcf67266dabb40f70530252916e2330f1bb5a69b 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2018 by the deal.II authors
+//    Copyright (C) 2018 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index a742639a7b50974aebd77c59d05e81c74141c4df..2f9836be53687efefee82a83f2665a280674614b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 58337749f534a229d2d8c319212a248c24b3a9b8..631284111ce2f2d8467677aae0659d61190755bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 12be89887dd2dac2b277dbb789e4e63e60caa7c5..e91d9041b09548abe234c458d4df96428355fa75 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 37ec2256f0d37dca5a5677c4fa318ce9e6f65a9d..1098160592160411b279cac0562c4f2d842c1ab6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 805daa494c78f02564440f3570355da20ad64ace..734b3353240e195d2868b7db6a2693a6936f8141 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d62d24102968a6eeeaaa57a4998924aeada9a8f..51fc59d363d63a21ccfa6f5e611097f28510e088 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a198a90a923f076d829b2eb3f5007cb7117cce7a..93b040847a2b0170ce00d4e344b7f0c09872b8da 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1c93c9d47bc0d93e5e163a2c60984c475cd243c..ae075a2d015c3557d4531582c217822abd27afa5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd380e251310919a5a2cb12f3dbb9271295a1a44..2f90383957c1534700e634f58eb6d7824982239a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fc7e917fd21e807bdc394da214f8d6e92915e3e..64877f603f7dc6b6003827a8f31fdb983d9901bd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae3c448a96327dd81287222acdc250899a12542f..7b0b68517aeec3f32386224772254307e2bff787 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e959c4b7a00cc0cea1373f525b849996419925f4..5c05095268cdd4eab6f6ff8a6e97f670963202a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1818f663c8a7f5050186b5a8754f05b0ed41861..86422f080e515818ac0be7c0d5635a1ad4c51e8f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e0145d7e6c2d78025fd4bca351ea8d0791173ddc..4064c73232e07df0e213c3435abc317cb4f5804f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b18c2fca0c0fea3494ab4b5b23210ce07f3a6190..e385799b1396c2033985b89e629346f0dfe82651 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4311bed36f7be509799c9f665c5ddc15ad853738..f8e1cfbfbefe84f09b5934fd823e2fa0b00eead0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a11972169bc67f80d5c7667af69d0e6cab419d9a..5b0dec2b2b105efac2f82d942cf4732f4a1a0350 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39fb5711aac9b845af1bd8efbd2187b431b22e5f..d82e06c1ea0e35485be648348ed20fbd3b1b52b1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2cd57d93955e14d91ec5f7faea92012acd3e66da..7786824aa8ea456f8269fc8eb6fb258e54307967 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28e1efd20f311975c464c461d6830becea8659e1..ab2b68a24cdb031842493aaada7e73a30e54fcd2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 76e15d29e464a0f2e989164c7063746428935e08..8f5913ac96a353cf1a7912e39b185f4d58ca4c39 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 193d54878ed9fd945286e01847487c0ea4e2adec..3085bc966ac77346c19bb98944e292e97d6c1b32 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7706f0f10b7f52d4e47e08f09969dd95da968507..53180d2d80361f50e90af0a758ecb112ecc70cb9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dbca96cdceafc6146e70f9ca3ab4ce061427cfbe..3c686f6aec95f86efed8ed8c493c6943f9821be5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 60507d5d7a5ad596386cfcb762c06dabec7e82cd..0b3f85912d3e51a85a7b1c3ad54bd162995dd3bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e58ccbf6f10065bdc07f2bccf2d231bb17c77fc3..d341cee3b73b34c9b1fb71517aa23d4d8829817b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21a35261ce0b846b05f8c8241bcabfc2ad6eae17..800decfe1a2478fe6331ded3548f88a99aef5c71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91e1b9f076cc8ec75eb86a30d94e6b246157ea0d..263ba980ffa9e9c4e360a3cb33a8334f69689b42 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 486f30a515131fc0e3414bda7a7142746d226394..f61a4d2a9170349763768b004bcd1d7ba8b6bc55 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bfadaf254c8dca698a21c7b00d00e233b62f2c25..072f6dcb55a1aff3f4b73d6d7a929103b7ea0577 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea52b8bd9c759b376610d4afcf11354b22e56578..9b3c6e75fc99d7ed7272ff6ea6801bd0e4b569eb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 45af8707d4c7b8df5d6faf2e26412200d3aad981..6300edb9e4855fe57b4fce91dbfa9efa8a7a59f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 018dd3523ef30d06f4103efb705fead9e2545b0e..e4bf8fa25b2af0577a0121ae967ddf970252fd9d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f037638d8711acc1d91f5ee922d15929c20eee6..ad3e1c54e9b1de9e8059d4701b92c18f16d92e26 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee02195ec9d7ba007ae748bc0945bec02cfd92c2..d76fc2640caee762e7834d8d97124dd46d106085 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df871f6d7426205cd68c2978193012ab8847c181..d16fd908e33538608754519212d519c0ee7c91ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0d6ef9378fc486efa6b71dfb013f2878b095359..f522196ab66f7356d1ff332eecad9d99b25208a3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bbe4740084b431004eb8ab3237caae765f2e0484..a8fa1de2737ba5e4910d48a36ee57283c3c00401 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0d0e5335da6e757e5724b44442df1d9da8596fe2..c0eddef0a8f4e2c90e43e0714e9173d2bf35afd9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e99efe8d3ce216b417578d3fe4ed32343bb9bb03..82f3c814f22c3495d7accfa58ad93425ccc3d4b3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d691ca0f5d1e8241be6f9036c33e0b4a21bf76fa..ddd576d6b334692139859369b315fb41fc84e224 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f0f67e0b04a84cf3a04e3ea1b0dfb1139b5d229..1789f71b950f11ccfd45304e1813f8e42c9a1a17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95a5cec8e898133be5fb4917649441b14b8af6e4..2cfecf1bcf047c35207890ea5883c3c2de8e3681 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b6251951ce8109c4e2871f4e198891ad4b65b616..015448f0c694bf34c0ebba1a1ff7ae9f2719318f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff93d2e881be87bb7ab7c89dbe7cf6ad9d3a7caa..84485f05ebc4e3a7c372a047618aa6ab8c549e5d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ff66e7207147f5b25167953e7a432b7011fb1e0..c14e090e98fedd9019ec4593d80733b35adce24d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c15438439772a9cf0154f47008338c6ef0a7ee41..c5f71b691d7a7538e879aefc19d0e0979673c7ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b555d69a33dd5306102a4a14c803c21729606879..cd4a92e3268023d3cf457bd1c66f39fc0c1e4228 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8ac53ccb7083163d0d21f725384fcd95534fea78..a27b8decc99f92b18a7ed88e2cc3f215ace81385 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b991e8e804be0c0a67ccc57cbbc9e2b6e5b14b2f..78d43fffce77c9735d0a2799c3614f83302fce2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 41b3308af9bf4a331b31174087f6d42c7440bfad..11a899990941dd8d0a8c85c3e1112f686451d150 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48159a89f5ab10b01be81bbd6e9fcd3ffd50d4e8..886e848890e5f398b7c570d7bc2033b971a594e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab8ecaf802335ce8365d1f1f4e27a0606217b7f8..15c2c382f6333c20ec9b85efde15e85e59df8cd1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 920a26bc9c39c91fded90b48cb103d2783cd1e6c..03393d72204cb12156a1ada1451e9f108e88c79e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fcbbb3a209cff6dcde35e9f0a055b7cae368a249..ae6853c9f72f978bbc599efce7e25bb1613e720f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4be165967d17a069406f0e8ff61dd0690dc69a05..f93cc3e397663357f87d9c277612bbf65e36a31b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1a6e06b5e5c77a73749991a7eb5ef269efc278f3..44a1c923b492f54bf3a7b9e09ea3c9a7c9a87e03 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cb667f5e2b046e1e5ac5a4ce579515d3e4d2ad0f..0549283e7de08a52b9e2668bbb95492eba698015 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6cd1c123484aa13346c94be5394c64bde450fedd..db4c0b86c82ea80c92f26a03796d8ee5103527c8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1ec91679458d5cad63e5811e2f6880cf626fa825..e7d7086a0ab68b9f6b4c7a38b35454b2ab410e96 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1662a028966a5fa87acf54c1b466b2d20634507..08fd8402233dc0e54c44be44d5fd3767d057179f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea70a2a386ecfce7cc643954d1d842e3d3a193cf..37f93f85738af7ad195067d0e6c7b70f88ce78bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e0a86653f95454a0eef05aa157aa7c7f06f8fa62..fc6feca9d0b402fab3b8bb2cfd273341cb6d9a2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4bb63ae5cd02d13e47cfda2a3b1071d983e00a22..0216567469beecbc5dd3499b1688e8986a636aa0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d036ee582b72b15b6693b8423174c326bf4cf8e6..137d64392b3152398dd138605937e24e80d07d40 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50bea3719be37cffc5d4a0387b60f64234678fd6..21c490188fafb4f60c60d337302da0813a164314 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b800565836ecd5fac9b91bfb9737b703a9d10d84..6ab37ab51c3fc7e452b99ba66fc2109542886df4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb1cb12aacf966312c066db0b92447b3555d4f3d..a7608bf12703c90555504fd1137d4f37988af769 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 907c3b61af7051bd68581e98f1b523f361ed5a45..b162e3374003a61fda0ee0cd893f90631bfc9dae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4a53d8eb9f2563ccd2e2e11e5198faf5192b80ed..10ab7d150fd8274f31d11a4da0de1cd4469acabf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6060dbf344d90c888145b1f3c9733a6ec768208f..606d4ece6eae083f85354e5638f6c85e80fb4982 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07ad86614e65eeafa500b1b376b12947561c0dad..2865a210a46872d29947e424a890b9a7bf0e47f7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0c0cfb8025c4ea69a19a10e2dfdb451ac9462f5..bbf8c1ce6f329bfcbd70f279eb5ea6d8c8bc1da8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 798d673840fb60831d87f7882560fc7ac507dac4..d6915df792f3c2f40f5be4ff708a0e41841941ee 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 85e9d9c5772e5c3d67efc7ec2fdf4266311b01b0..bb43dfc7512c35632b6df9c55e480838bb1aada4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d618c9543aecfcc02a5dd60418124363aa18c024..c05ed2daf5765f0aeef6e46fb2101732a99ac136 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 25f4249120b5022112b3882b57f316945bb27240..eb7b77daa94dc1f7f5783a12f901cb31d3b7e3ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed89bc0a29fdc07f43fd5855a3c02909b9dfe49d..7f157cd03a27833016c3cfdc382a048c52ff0432 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1239a7fa8096a7e8bdbaf050ec3ac9dc3a77731..0633971f38150f35cf7184fe57e16aa6693935d3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f914b6af403939f93aa0e665506fca7b51c4416b..6267797d56bdf3826b3543c47ad0c340a535baad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index de8dc77128c11d9706463519bc56c5acb9027f6e..594762029858f153749de03958e6df514cbbbe6a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17da4390b17c8af667a8df966fc3d2d2205f88f5..6c5df11e9a23e1913b51bcd874f81a4807f2f126 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 133968282238ac8d4f78630b9c8b2011aedc4e7f..13612f68003a3f18eaac9f482f518c4f46ce9751 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1682c2665ac7a1918fe7100f41a72eaf9b1e3dae..b4c8fdd46ea10bb60906b42869094d8433a1d395 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 459b38a2ef94c9bb039bf88cb5c747c6a15b8f06..7637199a6168ee7c1da388abb677d5d2f6f6149b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index de8450d9d5e0085bbd527f8719d1ea5ba35ccd78..d81e0f836fb93b00d7a4fa72be72d508783c2ab6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f9a74680f8196daf7908d3339ab7b9069fbd766..35e8dc7baf94f18963aedf7077fe2e9bf0ece249 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 038c4658ae8da11eaa8c25630237db03510417e9..5408157aaa93a2bcca34ef5abaae297bfed6a87f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d7b99fc48db320b22ddaa57c3c44691267f4584..58910e3e1a344a3778ec7c78940b6df6eb1a0272 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dcad1c1dbd05ca937f877dd3da7707e6a98d275e..746c3732ab5fd4d29cf2e9efe8cadc9fbd774b66 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22b3167a67a8e37c5f3942b69ac5c369f7520a64..d72d57710eb68fd99f59204134fe08e9eb0d9769 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31697ed409f45c77ff899c69b207c107191d693d..7451e767d8eb0f6aa9dad3d80476b4978a6f714b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63d417ba9b42a72b6abe01ee3b29565cac2104f6..3f5e532491c0783dfa3c983f27e0e59938bf5fb1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 134cea7702687c7b4cec31fab25eca4f7bf82fab..38074b94af24559756ca73bd4736b4d9d936e426 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b3c88d57d73ee9b29fb31d3f3e378d63e0d13615..f3378600d09023fe53eb8681c9a70b84ed6b7711 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index febf44b72219b0965ba1ff034c7a2b8950f374d0..511dd1faf6c0ce356c2ad2bed60b6aa35406a330 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3789c1334a519deacdcc09f5c7682db97f8a3bd6..2c2656075fc960254b7e75fb7ee5d922d8dd6195 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a08f9776dece49bf7904bc0750dbd7d25929e0ef..d2da9cede0656b0a1cf9ec519f7b1a316fb024b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92f5791722f15078d11feedb494f5f8c19dcecd5..410ddd53132f908fca8cd56286efb6ae9799c45c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d1878f0702d4f803542b28452a516f191ecc27f8..12465baa6360343e165131777d3113a3dd7dea7e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74e88bcb63398b89672c5dbaff32423c0f86ea3b..d5eea1475b47e283e011fbe22c283a0689be8183 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe7e504f72e0af8ac6b52c7a8e20ffe64f0ec7a2..8e979886c26ef915d67271670c3bcf2ba49f0845 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e503ee79a0a1075e8b8f9419b9ac2f58b09ce3d..e622df8b5f218202b14d45a2fd072aaf6430ec38 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e32096b5e772a94a69aaba0cb7f38e582379ad1b..ef325e4d24ff55cd15acde7e9a6fd7e963d42998 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5449d1b3d6b2be9d1a9053f11969c28d03c024e1..b8106a8529f96a2fd27f63d7d348556a286751c7 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2017 - 2018 by the deal.II authors
+ * Copyright (C) 2017 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 82b686ba2974f476b4c23265de31436e2527e639..0ea7392da7b82f066c13ab87df19df877a06923e 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2017 - 2018 by the deal.II authors
+ * Copyright (C) 2017 - 2020 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
index 1a7f3d4b78e2f93bb94ddc17f62fb3ad25f9cdbf..e265d6f99c5601627dac360bdf5c69036037b572 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b65c69f6d8d573bd1ea42cfdb312f1f82c813b89..f6b888eeaf23cccd3955d59b4e63294dc0dca9f6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4bc8d7898034d4d90abbafc8e6eff1c8abf76d29..c7a0f40978e47608828b65e19ea40b2f469be9f2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88d4f5c6784f05a7528e79d7c3d1963b33d00c86..b5e08243181c1054699e95a82929bca2839de733 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dce4351f514d61fe12ea3a0bbe0c88977145221f..606422e1f3d93712608580b1e4a82f66164aa44a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 709f4d604d76e636055206ae2d96b362ca5e69a8..e93b0706b8ac44ad9290ad476076c7f3451f2dc1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7bdbd763039aca592901a0ca4fe45150b2bc701c..d281c96963b77438112a9a42f66b3cdde70ca957 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9b1a7ec6c946ce5e0151c26b60d2a820314897b7..ab406a980a3ea8daa2b9a30872b51d9deab5bbc9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed444b30ec9f03516f317071be997e01fccc4be7..4b214999621ae9ee1b524358bea579153c9371a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 05ee576e3fb8fb40b5f55f492cb199e457a4297c..0abfd4f3c31a9d27d11c44f1cb24da4edb39ca15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eec33f7ad6aa6bf7a63b66fcfa42138cd044c19f..f0113ee8a0fd32e192ab04f881dd4e08fd3603bc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 382d65cc3b33800804c0142478383b4d1448f4eb..11acd7ab886291065b4879deb17cd391b09c86ac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68b5702b97b6b21de26e643ef29a6f323d2953ae..a021fdc337f495451138eb06351183ef49de914b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e42b0bb2b87aec56ef23db19521af6013649f4cf..4b69c936463fc3d57233253775dce298225947b1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e7a8db3467bbca54140bf51a824c0615c82c0101..5d4b149633f2838836c438e1a8df80f60690ccaa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6d720d0ba505b2aa13bb6598ce88782b7dc80a4..e06257830a4bfd3a26c0f452662890917fb6819d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 364e895977e6c32a2451eb8881c74a374143648a..3c4ad9013e53a31e8fdfa0efefc9a042a0224330 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 29a5c33db43cb6330c5c64a69a12e144b082bc6a..08c8cf255baaf67e847b45c481148edc3427f5f9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e9273378e081c4da789dba380b977305eae01274..6daf4e25ed28a2641ab1718aee00cfc8089c564b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b37144668ccc5e7cf9c5a71c9064257bef8c2a5e..55e07d0cbf3af2f0670bc44da1c45a6c54ce4aec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bc1570e24f7c8454526f11f15533b0ae004548a5..538d46afc4eaf76a6150f5f61fbd8748dcbc55e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0be566ec41c9d38927bd65167a4df693ef156095..f6e1e55e655260c697aa02a1ef67c4051d0f10a2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ddc8c047f7a50cce46db429b96ab6db9790747cb..8d364a7d1030e6f94c4cc50b5f9a070005b3a84e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 340884b708d6ad0003fb422926c29f229a98dcc0..34a997a46e19a359f5fdbdaed791653aa41628e7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81ad9452f40d5d0f23566db91447986434d87c16..e03d2be83abf89a4ccd037dda363de67c65f0e3a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e3c78557e2d5e6f7d77dfe8130d551675ce82c0..508b3c2f05e73e87aeccf5383fd04b42766e2003 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 84acb5d6e2642aa883428462f881a68d750bd505..d03f12d8dbfe596e4bd1097a41097c1962ec0351 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 55c3d4b6afdf2399747c3e6b241bd256528de7b7..225ba7d07d304eae3494bfe1798dab7a94f71b6f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1fac2ff6eb1b73e62efc6423ecc3318ff719fc87..cc2a0babe6547817b0c43addb7994185bde334bd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 501f86d1cbaeee86e5aefb82448f645223fbd7cf..d336ec8ab40e92e75f57f057e7a5c45af4dc1f16 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a9a65d0515e4264a6c143917e3b46393eae59434..bcffcc56e1652b3e863474a5d5dbd17b898e582e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ec9c72dcbe0259ca1bcfc47bab3ef30dbdad29a..f0af0b6bc164d381da75fe90063a296af1531d4b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9ac35be0a701abde2fdfa2ff0019c6f1921749e2..278f0a93726ad031b6bfbcde8fa8f3b554a4f477 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 491729369ab8b4c52023e890bd29a783716b0b7a..3b9688b9aba5c1fddb6dd7685076123c6cbea506 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a1c4c93f70f082bcc21b4abe4c4d92f61cf65d19..e499604be601997e440796404dc6d22e8be0772c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 912a4ef64916b6df75c5d4217c3ec72cc9feba2f..f3dc08511b8708d7dcd9706bb1b99e03040ac1a6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6dae3d6b010ee5cf3f21cac9c28c4ef0f8a2c4c7..38345bd59a4acfadeab3f3fcf46fb4a1d5331537 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2954dfc831350ac83114a3dca7d5e675f3f2fb35..c71d3dde159fa3429c721ffbda63322a3f7af1fc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 949c7decab8bf5ecd3b6182e6b3bc6d600670c9c..e5b26420603c85f6e6c4f5d0f100ff674c9a4cb5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d881506e193c643a5c389609b1ba6d0d6cf30e63..20b7ca7ecc2a9e8abbd032892fdf285048d88685 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6d3d5aadf8f7a3b2559305e55cd312ce128d7905..d6a7c8f14c000ee7efa03dd93b59a46e159c73a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74c955438dbbc361cfda817be569b9d5e93f2a17..df6864a15b1d6db50d134c16f6e2a0f30a1b06db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9c77b1de7aefe8c99f1f3426bb19156635c048fc..055449051c607d0320778e5333bac10aaabb7411 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 435c06ea1af60366309743c2403050c893b10f01..7eb46bddb5a5662470b645d4dc5af6d134598e16 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9134e2896329bd05f790393b6926c3b52f102082..0dd2d7ed8e9ed18894a9ea1c3b51c25e89ff8b30 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 186c1cea87d95b42ce06bbcc9a49aadd524cebbf..fcb952a8fbbceb2a52254d0c850908e3216a792e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33ecb2efe4baa6c42efe5b067ef6a5361b4af700..790f66e7c5760b1372afe1446ca599d79e795d15 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d96e61df8cd5e52c2c4680e165b52281484d1d07..350721164cadcf29a2a6e7d6cd74c596a5fca02c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a44aa0ce41e9ed7142a1e3c40a06bf2e25b0ca96..e835970be7ff83ef64a21b24c909b33c7e2a9c79 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 086f169807080acdf70afd6580d95ab6d4433fc0..e49b58d841109e9f46f1df6ada8481b26b6369db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33eb3fe4fe95b4fd3de59cb97c0fbcbba02b3de1..a44657ac9089b4369c6962d2239870f1fd55c7f8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7126c19a9e66eca264a807821411474bb9531623..7f76f149eedee57ad9cb1113bf5540d3b21cd8a9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8483f17986bec44a5222548b072b7cc72d15d0bc..53e7e0b66eb02c4c560f758134552493e6e5399e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23498118ba6d26052d7962ff5f0bc58bc78bbbf7..89771928ec6a55da8419572c1f74f8fd8687d9bd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e9cffd0d91401011811733e155434a0d930d4f9..7722f0aef4a6d22cac1e0bda18b82df984958cff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e814b4ac5e2fe77191a31bf9320ccf45fcea52d5..4f9f46904f22bde770a6e38b696c18b82071af1c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d41f9c0ab1febdc9ccfdf78b8187ca377089080..9fbce5a4d797fe81b1d64bbfc73d2563f3c1c275 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 95df47322676bcd88fec77dd5b2b62675f32163f..be281079588963246a5c3cc4c0de076b58707966 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9a5e0e8ee07e68f2c70b24728fc7e408673ae7b..2ab74943ab6ccb6d52fe4c7368f70a8d9333be4d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cb2258d9524cfe0a09b4d1b5b1cf504fa7fd38b..fc7637cbd192bf03c16f6c1d3abaab2c31ef4b94 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7cf19f0959271000ef0dc2e98ed1c5fd326a335f..16d8c590df167e209b8ad4f79f1c581d1af1cae7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f809acbcb9ef061bcf4c08e6a34d5dc61489639..9c355ad6aa6c71a0a163e361282e493494957dfe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d1b92ba4168b0ef39c26568a07a2072f66f9e8c7..ad2d7572afbaf1775f8d6f3876e37b32e4dddb49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f0bd836da02abc423ee78776eb55446f1cde52b..416f81fbb152c692f44196fcaf2fa99e9c17bc9a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a2109856bec7c543586c1610ef8bb8ba4a6466d3..c45be69531d35ca49cf329cdd38e1525ed8364cc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 394b49c82b56f5bb41307946659f7d22d1a5b6e1..6fe25573b5fc325d134c544a01e4aad79fea1ae0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cd09741d94690e97e9a5a4cbbe1e5565f9d16294..1b7c0895dbf3df8465e776bb306975e438e50beb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 91d3d6c53fb5afab86488c48823cd0d232ad702b..0996c3660890bd9e3bf71cb21ea7523cfd7dbabb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8315b594bb2065bf800406786cd9cf6317f6a96c..4a3fd66ae68ebb64f1708bf32af84933809f9c23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f8bc6b18b495dac0cf598fb3b6257b06465a79af..84342ab3cc8c0736f6158f859b668e6422f9473e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3d600176924ea21b2353974a83e34d93ae9bf523..8286d8c6904afa02f0399f2ca6fd972f936e0e65 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c605292b38887224733adb783de5989fba70f20..90f85caa94735c4ee04d353fd5fff4e3775b50ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0bb4c4ac0b4d74081bb954f6f2c3f1f55e96444d..870f9c1e6a1a852ed675cb74a0d512d58c2e0828 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d08bb61d1cc2a87028938e1839ac5959d2a67593..4e7fb6a5a46393410a66cad39260860f76254094 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d19b7ebe047d25a4f6c717f9b2a8696bf89c0e9d..b89a6c105baff55a0cac9c9f9fa2260be01f66c9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22733cbacb01f9d2396a3e1f8f156958d30d623d..a693adfd0db3fae0467453388f15da45e14530b9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d5508b692878403261df697b72040a5661929b43..cccfa3ab45d508f21ff87baf5e2bfe7ab47544de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68c94e19a9c7bb0c98a249fce658527ac5d5ccbb..eaf5504c30633be896eb279210a8fa7d7ed40202 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7d1e8b00223a841d1e8fcb3a22c4254b6fb84be4..9c71d6b306f0c8145414e513058f7bf994f9a70d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2bcc29bce087c311de53bccb2720906c0eb7f6cf..ae620ae7e8d3b62463a7c35c39171aa896b45d6a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9a4d75ebf74974586214ee461576967bdba98ba..0e1da84dca8f24c20c02c021a4327f72e25f9921 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 277ae06b02fb5acac332d6a1889a4174be78a106..b45e2595def06321258316498f49721d9c1680ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9bfe33475eccb3ed44cc594b24d3e32c25bfb903..e6ad9a462942d5ae6c7d504ee6001afd795ee2c3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fbe56548276fd4d8706a61ec7344debf649c79e7..a9baf137127c4a301b1d70ee08be361ac9563360 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6e4c321d82283369e89ebac7e7a39e476126d4d7..2c3260ec96b4639d952f594d1473217426f15e0e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fbd25160cad8d57b5f021b930e93511e9285062..22eea6cd163075cc8d9210422cf670b27f3d3c47 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2fe2744bf7396b61a5bbf5d1730de1e632fb738c..00d035612c6f90e874dd6dd6286a11debb944bf8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b1d45b26c531b4064f475a937d6c0302ccca62d..c13a302818d3efa314b14d0c83524794c121de6f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 54118a32f548c27e714c30c59762532f73b632ea..ffd40949877fdfe18fdbd8b6a60ad30bfd6e55e2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9574fd5bc644c237492320e7511f33825beb9bc7..c461e32eb8db7ee69e62c732f7336af3794363c2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e223d3078c4c16b0457d57fad5b33c1d4995a5d9..93df06d1d3d7c4c0acf09ca15e672cb23f7108ea 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 193abecfbbf6d2c20075857288c58a2eb4435a23..05631a7b451ecb093c40ed7e9a42d766834ed720 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4990aafdf4e1a94435ebf00c9d04d8a3597d9755..7561ce614b381c82b3ff687b826aa05b315ad8ff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0c862708f5757fc31c9ca773ee140e69a37b7bd4..f0133a49ff6a5bac875481346bc292d652a55cbe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b4bb4ee9b4d5cfe7f199d3058f15c35ab15c4864..6fae3b16d8afb2a84877367efc619765ee1a6ff0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa12d423aad5818c1b800e2eb1cd88a080f74f63..f3dae961b1c019dd2b7c8108657639f5e9cd6bf3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 603465d09c0d18f9efe4516df84e02cd036e976c..adf630703f442bfbae88acfd17f57a92b3142844 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e344efd2c35c0a7d4d6b57fbc42c667b916e1023..18865003c452a6f3930380473cb0c4974db03b23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fff5b4ed664a3a29b702c0ceb6c2d17ee08e0c07..39a5d7c8c23518f6985afc35c829aae76f1816b4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fd5c862ffa34dcb85ae0ccce70bf61973b2db261..4c37424cc6807ed4d9287ae6bc5262cab95bcdc4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f5a04d489a0bc65a5176587f5c8cce92b8c2bc4..47e47b5e8231f9cbbcd55f3bc950280be2f3d7e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0b50fdc73b035e702ab83acea9e5a568eb01c638..a8c9030f80c0e540bd5b35311a2e923d2f9dcca1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21c3b08b82238c5d06a03ca224410d6d76a0f402..5abf0a0814812313c34a3c7e8b5037ae20226dca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 78c5fa52f26ac6fbc38e562996665f43f70822bc..8b55a7e4bacee4c03a5dc68aee5bd04c695ce65c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c498de1cbddd466a00ee682fcf30e6d35368230..ea90b2d3a53cbab09d860a5d7dd860c7c8454907 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 07e34fd088aca2e35dee0263a254e3f5284dc7dd..06a403c00af19cfa24a8a5d82c66f260b7ae9dbd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f078b73b60e4f7340c5c11e9ced96c5da8847ae8..dbd22058743e54699e923cc70c84dd20a5f0b3ce 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7ce035e66f989f149253b51ee6f23fb55633a493..d0cf21b47a4198543ed3446af0fbdecb41313c94 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fe1c7d1c2cfff17dbf3dab6046ad7a25dda4e33a..6a29a22709ce946f9694ce917f6025b250a1f4cb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index de0089417b83cc734f72dcdff8ee3c40828548f0..d72876f1a9816525dd2819551267fafaf7e9a1ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d2ac000f9bfe2a5645d10f975ceb4bdff928d64..35170f3ba738bd758c1f1ad329ab1188041a81d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8dc0f59a2463de6b4450ec9f13042bc2d7a36ac8..41c659abc04a5df41f283197ae75c9f04ebde0ba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 50b6ad1d5f8c81d68d55919fd3aac00d209ebb80..f981aed224499a79fa521f42268a9286fa368b2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2659598c9d9e19478f3265fc8d103f78358d2100..cfb2ec21ea24b6ce7a80d0aaf000a8097bffa7f4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 67e502576dfb2d182fc6afe1ea040684531087fd..b3083b8f5f4b5486fe16e43bdf173fdf051cd1dc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 604d19dc58e8d7ab4ce819f7b4ec6822ecd6ce09..3730bd3bcad338f12e840024c9b14c28c63dbf10 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 741b2283d73465c29e63eb6d115c9d057b8ef563..4a5eb85cd5b6ad351e93440df3096e7e2e02b84f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9a423ddc0d4b7eceac5913d68b4c82dfec025661..3460ae6b4b87918fa1c3e219185be85562e8d8b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fc1576c83cc7a298f39594db4118489fd828783..2950f256e0be0e1cf9c4ff9270608696a60ad0fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae8a1a69af6a3dca94b4c6096fbe28e784dd6cbd..17f3449ccde7f58a8dccf30718203647c473016b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 94d1c1153b3cbe274fa8b239a02c4ae8b5e06d85..a8e7a94d219f19b70bf725ef5e8945f948296728 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5a4c988608eb6b27463f13fc9c436576214cb339..f4f753c9a8a76588524d421b3bc9bacb01b49b4c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 78530f42c4b38e3218209c87fb6294c1b1f8fb05..709981a6e5caf887964e289b8fab84cff3f9ab5c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0898de289fa1266195a1a473d2389337585409b9..e4d52b9e39857f129940a0498a64be9f628f1a4e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bdea2bfcc978c98cc38e6c3f9c033e66d8b52dc8..26cad52d83ef76ee7cf9e4b0dae54c5427249949 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 29711a5c04f50475850c313864cf41af9def31cb..d7945efaed04e61063b00c68e31714b1a0c8942f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7405066a9c5c51868964b3dbe5ef1622b09a9674..54c0bbcea9b5424204060a7979b28e95e7bb05d3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6f02b9057186608f0de0deb629eec680e582e7d..e4362ff007e3b6ea8d2b6eb1454510bf390581e7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9d5abf2b60d0cf3e00bda80628542aba45a40949..c27a57220c2ae0842ea422503002f0238c8f8f16 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e2ac0c90ab7fb7cf09169b3c8c40450e4f0b72c..7ab536559f3cfdaac6c130e3b213b79b1f45af00 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1bde6bbb0f04a2b5e49952b36f19935a8b8a2a06..9b89af184ab21705d37158d70001bb79de774128 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bcd955648512708e488ce0debe516f93401cebb0..aa36c01cb9b8c49ca6ea8380daba6cb083568f11 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f65da662e7251ff990eb26685a73c9028020fec..fffc4a9607a710893840d34442eda7d65e4d1c64 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33ae23dc129f71e08f959cac5c34dac3a7fd88f9..7fc0e945ee014c5ed2e81c6aa0a3da748bd88c38 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index da4e261c81d1c6e94a1f31a18c5de45039b81b2f..c3af07d02e7a4390d1dfb071883798e2bca94787 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4edb2470fbd5627a49bc5be34681f02cf0b3bdfa..3287ebe2c1d450f804220a6032fc0729530f2e0f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ab2ef1538148fa6675e72ad088da6e78b3d7213f..8e5c3029e50f3715e2440d6602d84e36a3fb2002 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c602e2b73efb2d4d3ec6b0fdf8a41bad628f005..9fcd10720837c75a26ecf8c0314b5ab9dbd63e61 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6cab1ee7ff90530f3996864468e03e54f796abb7..9accf02c9c67044abb8d0fbec1de5f07fd8d9a3f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8bb7f0685c0abf669173d0c36adebae03d31188a..d188960b2b6ded6a02204844b783104c0b1cb359 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d44c1859c82202bcd384907020d7aaec1d7a09ac..a1dd3616d675070818a438e0095d2b8346e6c31b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a8dd0a07fa2ca5fec58d1fccc5fdeb1bb783b394..849881ba34ad367c92360909746225202208789c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b22ba1405cf3c4f2ae397beeca45b7a6026d3385..fa4b465f5797fbe61722dc7c7d79e70efed65c9d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97f6cbdf2baf647802803efee1108befaa38c0b4..f5eab6c35b4a785aab6a6823532d5b0c93a50cf5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f40b4ff9a385a6b3b184c0ae9935fe1536ccc40e..ecd7655ff296666bb804fda1f6d5fc317e552770 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 972253f22948996cddb59ef475420e315c5ee80e..959c21845512af157e1c1675858cd141227a908f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b8c4ec9f89b9a5ee354c6fcb04516bccc33d34ad..b255b025a294264acc64da0848357e3b269f760e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1f04d474672d22e2ca80264540a069035950dfb5..824f206b4d919ed2b2bf4c733f9c7ffbfdb5cc26 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 157dc08eadd9f1fb40fcbe9ad90683d2dbf6ce74..488fc93e544181268f2ced7cfe926c7bfb38afca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c83a919c76c1b67d59db7f0b29198c021583f898..0ccc8a4663071503d0837709b7a4ff536323ab69 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 667074f312c4f301918ed372a10498c9cd92fa58..12d84cc3adb8590164c2e945fe50a5b6c79a9c57 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7e3b967a7ef7a9508a3b54c1ef6ffbe6f52da7be..08b27830696f609b145030adf504633933731994 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b25d5303afded047647ae6ac79e50382043b666c..9056d9a9bab4c12d0cb82c44d3f194b8af09d7c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df01819c5d9c1d550a882451b7842eb97238271c..e4df7ce5815d95c8d59df93795745be0be23dfde 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e55885dbbf1717284bf70ab9b35604b652cac134..ae905f8275bd467e77e7b745e654d6679d424da1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5fdb30f7691a31abbd94da95cb7cec5c1adf9f2..e18874384a1a3b083a87961e54c9d933c1e87af6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c8f354b65b1c31ed9b3a3c4830ef871d4c93dce6..f0e31f9643e2059e6bf55a4c842ada434685a7c9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c615f4e979921c860e4b7eedb8916785b15568c4..3f1529376d293f96896ee0532f73730b34a3410f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 39b4f254227d0d4a1c713a926f6661c893bec899..4e9a9af5360ecf4d6d9b6891180ac2c761543955 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68370e0b27b4f6e031360f23237e1f200c5ca422..dd828c4e3279d3326857f3168063f1a92eb6abd3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e3232228458270a1ee55f6b2bac5f8ad3c1dc276..444ca75178c0cd6996666d8fb5d737c4552ea723 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 126f8402eff0466f1e94efa0598504926f7353db..5b7edab75e823d5c03f7ba5512638aebf1fe2bad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 01d5b42534df933486e599545b8d517710d68474..7ae993f3a67759e29e8076703b94674fef23daf2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3dcdec84b924315c92a0224096aea5a625091e1a..ff1667a08a1cc6fbf7d934b64a475d9105572ada 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3123e802a8b53f93cf29ae14e9ec5f48833c962..1d4b384212920e73677dd2f334ac80c3f94a468d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 21a345b1f8f29724ca58cc1f438850edcd517570..f850258d44cec5dcd5d4ad44dc47cb7d814e5d25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9958ac525ea263e479b58e00e98ef1817f5e7bab..815a16953411d68108c5c467700f1c8025bbaf42 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7f311c68816518ef043e2b8ca69da0f70c0aba60..b8c5d16007cc762b907df9abd4219ce8e2d72799 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 216ea2a475d8697e43a3e974df861e2ba9413b47..be96d07ae896e72e09d5ba3426ade91e252fef8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f25439ab95dd3bfecabeb30daa4237746083b534..df7d40c2be1b7d02013986f16fb9cba6793905b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f6e162f126f397da6e65e4cbfff89986c3cc6b3..07a39b8f8c464feccaee4673a9457fad2bbe8387 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68664266d34951bd62f200e1dbf9d644bea824a6..013859a1eeb3d8accec0ffa5ba9a03f41edc2542 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 30ed88e8fbd5b522ec55219fda3b16505061bfac..7e726303fa75f5e76518957bd3c1f46ce7b0df7d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 13db716419c9cdcee4280d85a9ea861124aceadc..11ec2a12177b01aa7ee33c9295a03c20f1624dfb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f9053de8987ef046b385180970c4c0a7044c09ba..8400cd58fe3c9cff003c1b68b72ac70ad9c766ec 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 48655160155c0defcc3ca6cfc79cecb4ae12b891..1aa87d464d83386b26bcc3ad6469a957eb3dd291 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 82374ef343ecd2812193bbd02cf29d3350826492..b2a9ad073f6ba3cda86251f7d290a734816bb083 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d720befd7b3214a822008c7a19752dac09a247b2..03ed3afc1e39148457d6c12215d8017498166d2c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03e8a053e6fc325778b346662ea559bc6deeea9d..ed347d53d8b3bca74d2996395d3c7c4b32996cf2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a1c8af685d7e183142f792761688491ffdf63f8e..cfaf131be96f74af191c329a8a22a8be6af9ef21 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5747e95adc0a1c21e5cf18bebb61a65f76b83724..8fd9e8936aa38aaa1c08e8366ab73995fd6c85db 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f43596a0e860ce16fb8f71bdff19dcd3728221d1..28276e26c46e940c4b8de806b8a9550a05055f23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9ed1e3fc9abfb3a165a0bf0d2816127429694daa..d946db6a813c39d0480b8084f5bf4f420194f354 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f493df122b7d0949612ae61a933dec755121a22e..aa0c7b479a6463fc6bad4440e835743af8ddfc0a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bca9f9b6bd0110dbe8eb91e94f2b351d1cd57801..7648b1145756db72f48f6fc375fd2729764d7bd2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e2795ec92b67c41ad4c46be7f85a1a9a18db59e4..af222eb3dca856937ddfd194c5558164cf9b79ca 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9560f0d5c0ea34e5d58b3bb7cf93371590fcf2ad..28f0ae25f6acef1ad33e6e22c62e92791dfd99f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dfb812bbb8e5d4e5149f7215a52ee3a808915127..cacd855b83e9f11d6e21ddb199ecced32c2cda5e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bdbdc4197d5262e3e21099418e5e7a69887db90c..90457a41356ff2cafb2338d877ad3db30f77acbf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2010 - 2018 by the deal.II authors
+// Copyright (C) 2010 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4896d3838c5c8a66f64e5ad4135e6ccff745d7fd..0b198a48e384fc812a196be298fab94af9927b4b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 857b35be365884bfdeea33549b77bd2c9eca35a0..6da95d31ad0d9c8c4b1296ac6a9f26d36b8d7a94 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a6d60193d6a3fdd23b65f15983604812cd998b5..91dd8787a037aa31f2e1380c5cd1e78dd178fe0c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5600d047bf9f00b510e9e56543dd389ed3a4e3ca..8a6181e096cedadfbe9c87ea7b9d7945a988e345 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 157ef34bdfb8940a07afd78b5ed51001dcd99dc7..689499d1502b20c5a5baecba29a20ef4d7f5e532 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d2d83ed72376c6e4b30017776e230cece642a231..d2a91af60bf81fdac2fad5df16b81a4789a59cf0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 805556f016c6011a439351ac3d1fe7ba53698833..da09532eeca6798e20f55942d4c627294907693b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 23a52ab5605d7a61add6a39bdf247d1637f937e4..cdf67fff24a948b37a0bbec00de830c914eb7aac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cf23a218b8a813c88363ffff1934ffed915f4718..b54538e49a7b74ba4a896e4d022ca684da0f5560 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9f5cdd21923d725712d35c07826f5d20dadfda0f..528fc85be3634989f1db451224efa46af1f86b8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 02b196308c07cc3eab316d0d3640eaf93d0778c9..4b0baf6aec50557c5b1af4db397fdcb310c30680 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c00041c11ecd84d794e96b6e313f25bb2bfc5c27..04e9d7908abeb864f09690ed6324a45ec790650e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6c950547dce898776b57ed2354c35be67f1d76b2..265a8f8d3ebdf064c76f087d42c11f4f18ea75e4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8e392586fde43166576d184492c02d0bf0762b4e..215bf74dc3d0d7b0cd8cdbb0bbd76c11edb5f3de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 249de58ad514617e3b6ec57517b79bddd1a35c34..5b244bc93d0486cdf587113ff0befea7801003e8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 039a76c7c94b7cea30f6262a92f3e06e9f1b831e..5a921fe7272659eeeb394ed3efd22a1e9752f6b8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a1bc266a836fa324f7fa643ea75b3afe40b9a8f..9c66b6d2ccaa8a04fca8d81ca660b538951f4a59 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b8f496182702da39ed70f2d67995fa9d115d393..ba443bd7a49a7d56ae1ca5f49a97d3838d15565c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eab0c7cb607db2d6e4b4547c0a8b98d71834cad0..a00c413fcc8778323a7411e18de30db723b2e6df 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 96bb5367b4d587855766308fc9888eb590407d7a..0eb96dcb788d4c3df5287264739426bc8080338b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ff25035f0d427065196d64adefeca8f7cd909678..06b2f745b785cc0e6263674e1e90d7503673ed9b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 02b9ae1a57011e321f839a04620328043ddbdc93..cd5067c36ee1cdf9895bd722fc930fc17579712e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b29abe60c7ca39f8144bac7a04a5c3cb78794b45..7ddc7de8bd9dde87b012145127e125b6113e1a96 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d857535b1ad4c6b6ed674d3e2f219fda05d42e8b..7b8c1e1ec6a8174dd5550e977d7f8bd5a42addfa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6a419928beacf54286d5c3ac6cdbec6af14faed9..c72dc448ce778b2bff58a93aff078a34737f3cba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b46f732204c7e59d5d526d01cda7e3186ea6aa64..856bb9e520e715b92e99cd5a75b6194b6193dc21 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7eaab51be6ca75276b0a3f258a9fb2146cc41f42..8266826143e2e7e12ab43852bcf82842d8bfa3d1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e128d8925263d15c7f84e7f9d9a370df64261fd8..d767a448f9b98ecafa996e2fe64a3614784d1e94 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74a205c4372ac10728528959101fae629df7d123..4c07f3b288f1fd13dd75910572397317549aaf66 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4c04ea67863d4a42abc71977baf4191443a08479..0845525c15e6f19c2b80e77e4f1538f51ab75d6f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 67612baa6bd4ebe6978f6d205a6a962a5b4381fa..bf3b860f206fb0d1711148c4dcb0795634cec045 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1de795b84b2b4ddb326219dda5fb7af06d26e036..feec857391c437ff98fef82704e56f66c62bcff7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 403f69353247975e63d426a1d6c1c7525c83b84d..e3b0f56f5ea40525295f8d4a96e082c552377861 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f2373aa70ba4e78f47c864cf881051aeb42240fc..10c01b85091574a0d37f872a09ea609976168368 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f8df8114716647a3c00f7041cdd1e7c6af8e7c28..46ec780600e9a3cc0de126b140cfcdd9bf72e1bb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 63b73ca9098f5f4ed4fc19475035dcfdb93d236a..e8cd380649c9e9a23f209998a31788d72e95f31d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 882d81188ce76a1a83595106077b606c35b77cb8..ec2e46c278994c61bcc329f2345a519741f407e9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d28d547902048da36f273e0c7da797c62e153ddd..ad3823c225452d6035afb6136e03c35366fa44d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c84954b2c455c5475fa4e8e8b512ea119ee13f7..fd349a2bbc1303925abb8a5e2c8b6bf957df62ad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8063ed801a6885112169d88a4a66f584b383959d..54e82857d7e9cd29e9dbd7056d67795d640829a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ef6182abaa477f904057b54e992d6bd494784e67..88a9095f7adaa3f48793294f91f64a0fe24b1ac3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3f1586501293df06c19a194e2e87ca4f77cba578..af0e7eda95b96b55265a643971006d0e73f317d2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2b687426f88462aae0b3f53df039dccf9f207eaa..2ee4d458a8f5da0b91e733d65a9d57b81b459265 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a38b620cee4fd6d86b965565513d6a1b7d45ebf6..94c08f381f5b4eefbaffb5442d16457c2e27833c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2a0cfe0d97d85842320a6171d1d5d44a2cfd6a06..19b6e4874fd94bf6f9d5838245983139301adf8c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 15dc4e794092236ac7f29609d477196b3fd74e1b..696a03c3bb9f85dd289169eeb416e9bea89caaac 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6cf0d2c4e79347c47603755d1e1b9e87b041e539..55f347d67bcf67ecc328c7ea79f5f2daebf3fc00 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index bebf75c6710bf7f23aed7edbd63ea1f4ca5e2abf..f96fb96881590794d5596b83c4d080bcc18fd1f5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f3b85e858c7598bc881bdf53afd0ce5c8aba500a..c97c1c7a7039f9d0ab1ec6fef628399c22f09891 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index beda76a42d8df385fdf689784ebfef87f93e686c..541cd00225e1523aa2c5e628d232e191ed3f0a6e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 52b293a879faeda0171e9ffcf1d5a186ea2ec908..d7b2956c99a07fb9aaeaff981a3eefbd0db6e6f8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 68419d9d214d87083dc966157ef866f3337106d4..6c2dbe38dc7b42eb13b6821a7b33916208a0f453 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6782a5dc4a5488b4faac326be4605f77432ee402..3d1308cad6cf13227cfd83ac169431dd728139fe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 - 2019 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3bbec805b7ff7192d35b99969e7a36a7a834d0f9..8228c8a841f0207027d58157f862020779147d3b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 79e8000b1e89f24768768751dd37a1f613edef05..83c334cf1c07d3a45bd7c505da0d9436668575c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2001 - 2018 by the deal.II authors
+// Copyright (C) 2001 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d8caab5d74765e042005d861b5829fabd36d71af..1501c2cc37b1892b9fbfe68518ce0e4b611d8551 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e1bb5545e5e559c41234f6fa4fdb837659be3823..0a031f4d942b95bac3cc9ee157d2eb5ae1e00e71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 352e1ba92abb60dde6d08473c4827fec2e4c020e..7ec147c4d218e677606032c565b6b00f3358ca6d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 44d19589870595a94612de4c52ef097b29b61cdc..c069f51d8e3f1eddbc494fffda15e354fbc4218f 100644 (file)
@@ -1,6 +1,6 @@
 //-----------------------------------------------------------
 //
-//    Copyright (C) 2017 - 2018 by the deal.II authors
+//    Copyright (C) 2017 - 2020 by the deal.II authors
 //
 //    This file is part of the deal.II library.
 //
index 2b165a0a9137cea671d1a6bc208cc092455d74ce..3b3c576611f84ad8e2aca099b7564eca95da0256 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f79572c591608a241b3e7bb34e5aa46fad3dd97..318e0deb0941384808a1784a5c5e63c2582f9814 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2f3a607d02b915c465973ca417673c71d50c55c6..e9bd48e9db62f514396147e2dfe34ad6014401d2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fbd5c9cfd81d5b203b27c8befa8231f72e58102f..2d663a73963ef47de3f172bea0c0fb3c39c8a6a1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92d7fceb7a3ee46beadfe36d3b794f4df7242f4d..58d2eb94c5759aba7284ad256ece5a104883b63d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 172ed5030d036a69c4b0138ec736cb0478828344..508f9e4b9da8fe1a52f36af3fcd4d7421e80ec68 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6023e0c295a16fa588197038e66d611a2fbd44c8..c362f818e9874cb2b585d8d92807695509243364 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2019 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 611ac5a1729ec23415543c7f5bef7dfbdd304620..fccd8a7c6da615fe23a644b3c2d9126d43475172 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 31c41edc0a4c4c2584341ddad5a8d6f97bb0597a..5b44a9bb235c6675641fe02cc8faa35e47d472d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33f49ef5386e1ce2b7789e5bc7464776248869be..e7d54858f82841635a68f7a4da19b071fdcd83d6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3db3c9bfa603e2b73f509afcfa16929040ef7691..642acc9c547d54dca7f179d496bc7c9b79a65426 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d6b66861d9c04531ac69ea34e5969c1c6b987a88..327e03c677e797df8a869be9460dc6157d658ed9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c2345187fcf896780f5a26de993d9517c3813353..03ffc650fb984eb3ef7a22c9f9a5b8282bfbb2fd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 22503506724c68d5b7c47f42081470c330d3fec5..3d15a5a4ab0fdb4d4cc99de5d0cfb07ec087eed9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 002cea84906f64ea676374eaa51f31146e3a7baf..b03566eb59b9ace3752fb5e07d318908f6a5d0d4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1f8b3b423c1bae3834999254e50e46b06e96c66..061dce0060abc019460a445fb1b3e78ca92835c4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d3564ffe1d61cd735643c0d7baa4ff91a39fe9da..f434d0a4e85523768f5c6bc4d67f615d0c1dd438 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1dd812253eecd1fdc05c80b0fbfe338fb9e86536..23ecf89e2a7c963a20aaa9343d49574acaddffa8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index aa6fb936fcb996f6c48abfc60106fdbaed23400b..95cdd46e4c904f6a9063e2fdb6beac85b67dcb18 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 16a69a024357a4cba5277bc713c0f5ff00769c64..5a904d75a8a01d1341bc85ffc8c8a8de9d8ce298 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4e817fa32cd68a9b7d4b669fb86fbefd7962718..45258b64fb881bcc2abc9f0a3e3b86e1fbbb5e85 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14bb647b63df42e4d8af4c6388b01a9655139923..43e56060fdd9a590d84f372de8037735372eaa23 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3077c4596a7bd18047dc75fd7f790b18a02af515..cba92a6a0b554cc53cf66651f87c77178799d3f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5aabb2485609f70f0c137858d84ca4d93d0cad7b..3474a81b4b8f77cc9ea111210aa50dc8e134bfba 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b83179bc8ebf3e7ff24499911a152ee111583c47..6839b5bc2238f0e1eb867593e3fc8fe0aba74404 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 02d94accfe310e5be1096972b8370c330441812e..88a5b0a7dcdc683ad646708679d1fce4aaab9f71 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 59c485d996a87f5d2d148ddc6bd777945fecc913..604883981532426b7181636014fcc3f30faf39a5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 57800ed8c08e17d68a8557587d55aab2b7e78192..3b2d40cfd444ae0ec15107874179faac653d4bd7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5b74d6f572926a03a5388c46e97090cd91534ce..06af8c9a2f7b0ce284603b9985c85761a6c2bee9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6ab6ee20110e9a2ef3440cf383c4fcc2d83170c6..7574b503a47436f8c4da6b2e4e359ed6c190e371 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 49748c3ae780d042c475e8c481b4592df01b0cec..89634f375a758d462129453ccd8b43ac20ee097f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f62bcf5805f742a5799403410c75b01aa0845d29..5187b41892347774beac6f3eb87634991624072b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2019 by the deal.II authors
+// Copyright (C) 2019 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b9f91cf60317b7122c35f4ca88a0e06720fd3d8..1ebbbbf4ed4d4272372571da8836b55d31522154 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 88b22acd7891787c5b00bc9fbc5b68a11ca96717..a717c1765693e4621ffb7523bb0a1a0449895033 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 33ade8f8f9bbe47b36bf3f1d488c48a0317b0ce2..a0bd67ab585f4e9ab54f5dce02330ccecab04e4a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d0538b9564743a00ec6057a47125a2b4b2f4a1ba..d4d3ddbf9fa3f241837d4f2413e7eaf34755e1c9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 305227455200effa65ef859c734ede346590ba32..13f0aedc75783586c2e7cc405ac6b607ad1abfc0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ee09b48508548a17948182e065201e5f7200ba83..74e5bfb7cf9b4c34c5f9790e8137be582d7c640f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c6af36aa32e5ccf785a99bfd57782a13032883c1..1e8e66f6128fb8cc5ca79f609f085c7202ea5348 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2006206beb35134d9463dc8899ca9a73284ac264..0c615b4e691b3679316efe9b16a9598f13030def 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1476ed647fec82435effeb6fae8bb49b464739fc..ad46a987dc279283161794b32830d4fcdf9d2885 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0aa33559b1d40f048a3c7c46e5fb1fc0060033a4..86b39a8f08a1cb283d3109613bb2111304416180 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f223bcafc69445b317366cd705a38cc6a2acadf4..9036c288cb86cd4ad13969802edccfa656e95acb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fb7aa77ff39f2a64a3913ed48729a930ea96ec36..7c812876493f46dd5947b1c0fdfb0af0caeb1704 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 566f029c879a0d1065c771db05d5e5ea7179b847..a23bb85d077616da3d33ed1bb406b7013b690ec3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 180e18e521ea791d9a02cf40785e8611dc41e54f..64621e6a9fdbc86c517c5df3d54ffc1d0f705e49 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f5611c8b7b0d9f55f7f664d9dbf9225675434511..35389b75f6d5ddae2d79daee943e36fe754c1e4b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7a4dc3b74f5208c2b82b8fda5807096c9669339c..0d71c4510ea4b3244135ed46c2ca3952f5de2fa2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c46d06dbed1b3c61a4c54faf887d8e8e719a441..7559084ab2da0a2f2d086887c9f11e48e7f4c11e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6cc76a1efea36b27e895746b8b9815f1f48faf6a..93a6cc2a1cb94535b8f162b790d2180090b2859b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 09b61303b1e603d5e4652f743ba5e5fa3b537332..ba52f26a3d26b10f197d125d5f5828a49d048b8e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2d282262a9a507aeaa2a016e2726e9e050e8bf41..46002c71e10c412bceab8f612702c7376b26b587 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f0c7632d5a4ea23bab538a1a472e7c8039373b4b..a513c50941dd014bfed4822a9dc1353cfcd6000c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 11e217639e7ced6dc34296de857fa376a7bf6822..b2fbf49a49dfb0cc36a8a703af4a1afa3383a976 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c5883e80f1206c873db828b45d1b944855679d1a..b0b955896d570874becac31b0423befc26a5336c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e6aaa01a9fcc5a32108fecb0806a832a0cb6d797..96959dc3a85af345e94f1c6f89e200dcb92ef083 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a0d63831787e57b68e3434a698237214fcb7bffa..2d04a0aca18c87a6da4d04bc571edba5273ae9ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4d6340f778c6c6dc80649aeb3e564b37d46bd3b2..911fc338e056993b57df00b89071c8a788586883 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 662824dd616be71a6d1409d72928349cea0a1ddc..c9605a343ed94836676a1267933d53cdb0827104 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0314361052136a007980917a3431e4d174f43631..7dd9f8181b99203c47f08f4297c4572fc88bfcd9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2005 - 2018 by the deal.II authors
+// Copyright (C) 2005 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a3eacd35f275738c8f25a8dc35eda875d4dc57b2..9138aae932cfb4fa1fbdb2dcad1d2547215cd15a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 664b2501af270861b8f6a099d74d16ee4cd606e3..d9a5fcb0925b46f88539120c878814dfb3a9bf25 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 452d784f1af8de43f46733aa97c302c07d91d7fb..3e4dd155a38e503a023ffa04d49f03a090ec0dff 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7cdd3a4ec1497c9a4e01a641ea994eb9593a54ff..7a98be62d191140684205d3d20875c5d27288fc2 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1d0167674220e1e619c1c4569fc9cbdd809839fe..5700b8ed5236246a2a9bf6ee3d41662985d72abf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index cbf77b70ea1e74231cba771396d665ae28033dc1..5748ba7dbe6c8e564cf0bbca1f289c74427fac3b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a1919bc5c8c9149dd11705fe6f7425d08303c0ff..df9dbb000f7bc29e616e4b7ab156477bfcc9729c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f608520704d754b0c4b16e73f08b83c1f7597fae..2176289f98a890197e0101f6695dee2c0fdad61e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17c2406b3ef3bb2df4d9f6ffa8b6b5ca8c80625d..dc0a63382baa47f805142a711cf878154a625757 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1e3e7c9e26c1f9d2cfe6b38a38171f44eddc160b..ce0dda62e63eaf5f3f95253fb4aa767f9a275140 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c0b33c1e3fdd3b1f56fdb7add94c2c7c7d0cff85..23c003b433f9b9fa648dc56306c8201116cacfad 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 92fdd925c81adacd76ce5c869537096aefe05e0d..6da7f6794b4027316a22d2785957e732556f6802 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f6185e6e2ec09cc0b1ac3ed0b95454f5a83c2237..b9fe40790be2c5d54e641aa96fc7934827bf349b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dcffda6ff024c1ef4ce058be66a5816bb72a6fed..8d0e4d64a0cab4902002575cf4f6040833f683d5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 81f69e2bc2d1c4159ef8f140947ad5973a0334cb..e90091180ec0c197867842b64b7e6f9aaa63a6f3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0e48b8c64c6d3fdf7d9c7bb0fe084ba64e1cb097..84059c0ef13584b460d3c9a2938859a10d10b044 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5bc7ce2b64e8656bf2ed50042c5e0abae18bfa41..4340c6940bd7756e2a026d38b7dfd71118f3acfc 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0ebd8763b9304e693c708ff238c366900f1e709a..6ecb04841cf3182b92733f4e70981b2f76d9f92c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ae8838fd8a9bf65379bbbfeb19b1499ccff6de62..935cdfe4dbf1ffe07f77bb3f22cd5da35f2216ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6793df1040cd5b734e5c977891e2f2eaecd040f5..18bafa6c8c0030e38bf135e15f7d9c247e7207b7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 968d22738d2316b36adceaae0110392b9e0d2e26..28076f8359485a97d26949ab74458f6c2190076b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 19c14a10013d19d7d8ffcec75401fa096d2c0013..607151013f3be6b3ca72f3811edee5f8993cb17a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2006 - 2018 by the deal.II authors
+// Copyright (C) 2006 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e92d7aecae1ee4b01733f4ee3c6c222a3f658f9d..f8b6ae9d2316971626ac153fb128635013f2ea22 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17934dd5697894a91de5b8dab47366212267f0f9..b763d2c985a2c3ee568f2255b425bf039060bef9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1eb2a1ba2e90b3b4a62aaf1edd203562e14d28fc..422bab1b375639c1e58ef1eacfd18d28d07ec2cd 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d58b1bcddfa0bca3501c44046f4e80f7172904e2..5291545613f3df146ca612091cbd479d4ba1a853 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 74e46b916815b96dc7a9a50315bed00f6ca4617e..5b8e58a05e2afde4e14eaec55df3376052d16e76 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b016a4205299285d949d32401fe83f63548e1ac5..191831f90bd2f33030f2efe5aeec1487e2d505ab 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 947f2f47c3f34d8edce64f9d5e85e4df4bfe4a14..5a780ca19c7d759e155c9e8fb5bbea4d88b0d234 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a5815c5db9e09e29be5752a6b30b6c096f49f0a..c4607eeecd72a98bdd243749bd56f83973451d24 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d70ee3547a4b13f25c8bc5f7410d6220c3067edf..7e4f3c37f951a84cb56dc9aff8ea1da004aae441 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 1998 - 2018 by the deal.II authors
+// Copyright (C) 1998 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 172cf9ed0a1624da9faad1741a4c2799d3eaca2f..2fc3e79ab3b96651fb25c2202b70d2572fc2a94a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2019 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e49bb0878ec7ff522179194a1da15e7d81e25088..777429f363f2776837f4a2f2625ecd50c938404c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ed2bca2cf0a2460abb43bc370e405e558e6b5c6b..00b366406462df4fd1592a7535d3ac4dd3ba35a4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 00073b6c7c12360159eb6e0eab7cecc97210546c..37dcf6cc0dbee6b44f1d331bb9a623fae292a3fa 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index df09b5fad388315bdc55c1950f8c280ce84314f6..0a1dcc871bdba21555e570a8de321281b9b0d789 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fac857820c6a27c519e39ae59c2b0715784ff7c..6754c869ffd4bc97b54d9ed977834f3d23034a5b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 589a022962860e4d66517d45550ed89d7030c671..d8bc60e668a0fe60585f18f109bd117079864fb4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8f62639f9684e299ee2de8a460a9caa1e906fb5e..418d2251404597eb89c53d7d5ef5c8df107dbdc6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f7c42f3e64650b906254a80ab713e09e4609a1f9..745d879275e52b8f1c7a5317c75a13dab967cec4 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d4a9c531919e2124ac2e4ddd1ef45436077e2bf7..e844028c9007b91de879ae42ee0b56fa9f3fcacb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index caf7e387a123f1cd13ccb398a7a3ccab78b99eaf..97b0bcb95ee39ccbbda7c4ef1aed17b9236fa8d7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 568b934273d9856c03695c1c87f07d82d502401f..cc1b58bc7805a2c25f42d8855dcf15e4680d47c8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d2d7c0b8d1df1ecce3ff075d72ea388de13b63ee..e23f8c9c4e9c6da87572d3824e1af5486fad9c45 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 14e9cd723e87e25656f84fa4f4a37bc8d545cf4f..7e994560617191388112d72c5c54b604f566a44b 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6647b688a652aeedcb761fefaa7971c238336b21..e9c5000b18070d0f060e3999862a155740e4b450 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 97d34702622dc3e71e479758b51b3ccc1423ed40..26cedb5cdaad911f671440729f662fb5998af1a0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 71051f1c370b27ca0d0dededc0feedc431f96665..fdcefd0475f673cb097f682f44ef5c9595b4ca8a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f4d830315968303f21e30f8816551f90cc9f7add..7e6fb3c9c661a9ba6b537f4a7ff5970dd4bb346a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2016 - 2018 by the deal.II authors
+// Copyright (C) 2016 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ca51e152532eed055e7d80a6cb8bb1f7206c4dd7..780ec11ca3d3c61f11e9a14edf23c1939141ce67 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2000 - 2018 by the deal.II authors
+// Copyright (C) 2000 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 8c95c9228c44d1bb57703da2d1a70160c5ecc8a4..ee3a1636296cf182561685be17fa49b2f967da69 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4217a9aa5106d6d096814ff997f3f18df1230e07..a743b706452f2ed54de8c11cc542bb2c42b02d66 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2018 by the deal.II authors
+// Copyright (C) 2013 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9fd2e9b85aa153f8c7882db634b3225f93bf50e2..1c3de3bf81223e577a7e67d7261113a74af772d7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2019 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c75e1ee7bf71f7084f269390404d93e3d8b5d037..38beda26f97c17a8810f6bd865c9fff25fcf8465 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2013 - 2019 by the deal.II authors
+// Copyright (C) 2013 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2e260dfc251324f1277adea60191236fa361a58f..6bc6c334aa6a000c38de56c2f50d674ba47e93de 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2015 - 2018 by the deal.II authors
+// Copyright (C) 2015 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c24b38abf0d887a94454edb8bf1a1dc9deaf5a3..dbdb03c83a951ceadf0f7c6867bb362c01afcfc1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ec20640f9e477a0150f5f3a891c401b04ef14b60..0b946e6e0ddeaec0b222eae6b495a693122fccbf 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 46f6e1912692076e39c17bc557b4638abe52182f..620cfc420defbe981b3fe72af5ac1596e10f3a13 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 636d2d30be250b9fa3ad509e2d88197c558c551f..4f63d38d674252cdb0faa3cbfe4775cad37d554c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index fdaa2a50e52003a5e0c353c2191d1d94ca5ffa6f..6a5a1c74d7f842c487c16b2389efa7d0ae694f2f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index a94bd7727d0619c2ed7f4f168f648e674dd72ece..548d81a50d471fb9ae362b36ee3ac02829156806 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3ff4a0da420a1d2801ff6e80faf3ce43f80a68fb..e2eead2575e1d20a7ca8c61c89b9591153ccc6e3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e07edb959221b153639848cf167d3cb5cef2742e..6d51af06f7885b6c16ef71df7b82839a1cf2ae0a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d40c7c5518531554b54365c9d069287ebc8bbab9..a98d82df3cd4c394a9ace7b626153a0ed1ed3cb8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 65452778a5211958f59f48b98293455e61194ebe..32b766487089b0c595fa677dac389887b8ff8b0a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2019 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3184ccb499d552cfae4658c984e93e3f3d28591e..b28b4ebd2653a68b7ca6dcd82a77f81f147c2ff5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 17eae9a1f830c25424457daff4e17ba80f9d36c5..19c6ab99fab62668845b56d65a16f82e04cb4d7a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 03ed5a978b697c8fc924386471849a8ca8a8e788..c32198156355a831725746d3aba6b901979c0994 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b1ce6abf32e8f4f86f8555d02351858e87d9827..5032280cbe27f2aae1b9841dcb1fbc9a897109b6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 66d2b416323ee5d6f4a1292d039b1110d51b48a9..a31fe2f0a168107607659ee713ca4848fe581983 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ba74436c5a8afcbfc2cd589b8242b1994237acad..832d75495234254c5577c36d9dd40aa1cfed8792 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9de742b1220512f5214bc9e015d7296d6e1cdb10..f6c781e52c79c363210fb4a3e44c98cf4966cdf7 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2011 - 2018 by the deal.II authors
+// Copyright (C) 2011 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5b26f7a3b5b25d48c69b05b6dccdae9dcbe407fc..f0838053ffc34a424093281792a484f04919512c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index b5081bb07fdecaa09f1dd557c69f9d690aceea8f..75bf528d7100bf6bfc1e3ee5b4dc3a0ce2271fe6 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 32626ea86311340ac03887cf37f975406d006c05..372135e72e54c2a6bc7d1f56067e2e7c284f45f1 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index f1622d5facecd12a516f60ea53e0b7257bf7fa9d..c7690570afc325a6958642ce1218a439dd99fe8d 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 42eb4a9418756422d56667fe4ab4952a928258bb..bfc4cd8726415ca411873b87148ee731cc807170 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1fc20d0bf12d8c28a4786a10ea038c640f9028a5..73dd422bd2309ef5086237bc1ac8c82c0e4d3988 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ea6edc1b827fbb1f64f166489fcd151b6122e72a..ba87cc67263a9d68a355305cf91bad2b01c1e425 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2018 by the deal.II authors
+// Copyright (C) 2009 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0a94771c47e8988094749458ae12a95f134d7f54..fab57b66296fa50bf15ef4e514db64b878fafd17 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5dbcaac3af3016db6df3fa8a3a52e0fe764236b3..739cc5c60a1dd8d5e10ff28b478f2cd1dcf81c84 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2014 - 2018 by the deal.II authors
+// Copyright (C) 2014 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5c18fbd15b81e827615cafd6500e8b6effb60463..119ed02204ef393e73f83f07d7507843d1e197d9 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index eb6b6357672cf6c4eba1ddc630f9a2b8331a6326..da5b80797d42d92e245ce6d33443378faa168919 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2004 - 2018 by the deal.II authors
+// Copyright (C) 2004 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e65d68110108b3071e067f55d31dba0bebe28b1b..1d3d55e45cb878f4d2cdfc5936177b0479aad3be 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index c43739fa11b9560f824ab33f7feab91eed67edf7..e91de8a45fc825833e9b8b33c393a56d9ae1286e 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6b3103f414ea5a9a48020bffc982fc5aee65ae7d..8354e2a9c7aebea8519ef906598a8f13c58feea5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 2c75e273e9064e2aa96ea3025ceb537248473c54..06738d3c76b4441458ac5cad9d28171e788bda9c 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 28895ed494e6f805768aab900d9c949fa4caac07..4680017836f44a728bd1f90d56490b4f511902c8 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5ed20f4040ef96985d72bee8b0445a7b929d8d14..2079dca920fd9cc6831ce431c19d6ed26d110947 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2019 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 1326b7fbc911c05c33e1ec59120e9e2fbebc2669..e05cce10eee7fc5f89affe0e0b57046e86d1fee0 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 0f9f48e0a7a35a9ea0607231d19e730603fc731b..ea1400f77b209cc4b38de8e6f169ad6a55199083 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2002 - 2018 by the deal.II authors
+// Copyright (C) 2002 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d9a5508bdcc30c48c4bd07537687b59cbc6848ad..ddcb16958e3fcb86d082856e4c67c42810ce84b3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 696f91a6ebf4fa0877d93288ef7befa65da84f72..ee6c22a5dc9e47d305133f55e338fb770715a3c5 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 6465cbd2c058cde17c87234d254ba1b524e55afc..c6193af7084184907ad3ba1b92bd50c028a4fcde 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7cc36a2d923654ea574d6d6071bd6c96a42bba08..2fe9517e985628b43fbe852c6df7b05334548867 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 7af6be7ee646bdbc3f6b7ea17b56cbc2cc53d653..ece011f416775617338d10520520c3ba5703f03f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 5de65cf2aa8229f87566bef34b199999d136de35..09852e549208bb5cce70e165dd838f2d8c05f82a 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index e08f91958efe465832c8b25795694f959f61d5d0..801172af64575fee3b8eb9843fcc3a9c83572480 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 3c261b263fc4e50da237f965781141c14454bc29..fe5a8eedf724b1f378b29cf4281f4f908ebf4eeb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index dd2054db1cd067765f059f09b73581e6b361b46f..f9aa9d9716740f69fc887c03e028302916dc51fe 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 9cda4e89f6c9e5cf9d06e78572ad5918270b807f..4fbd1b98ea01e2c680d64befea54bcbd19b804ae 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2018 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 93512858cbb3e660763703933b3996a94d253094..83db3409ac004e18fa93482d90a4665b8fc0397f 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2003 - 2019 by the deal.II authors
+// Copyright (C) 2003 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index d1d50f610cd0afeda3c8f2a85966aa6b8a6280fa..bd4feac0e86df786f0b9567e3c3e069c2d159919 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2017 - 2018 by the deal.II authors
+// Copyright (C) 2017 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 4f7db6042596e5403b627b5c0730884e2b658ed8..32e54edb0e6dc52fb961d230cf1e145c24f2b743 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index ecad1a7a7cab8af0aa0540e6584c5e1f27954782..f0618f72eb40a5ae2ae68a48c456c0e1cc8cc647 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2018 by the deal.II authors
+// Copyright (C) 2018 - 2020 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
index 918322681d6994722293bbe58d20a211ee0fd063..4a66cfc91b3f2660a5e4e1624b2a93392646cba3 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2008 - 2018 by the deal.II authors
+// Copyright (C) 2008 - 2020 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.