]> https://gitweb.dealii.org/ - dealii.git/commit
Update copyright years. 4101/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Thu, 23 Mar 2017 16:08:23 +0000 (10:08 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 23 Mar 2017 16:08:23 +0000 (10:08 -0600)
commite56ee9318674f8c345dcd2f5fade330f9230d8e5
treef7d94c00027ff4f17d3e3e1e2e5489035ce521a7
parentf64a681605abd28dbb15aec83bed7f8da0e29ed2
Update copyright years.
443 files changed:
cmake/checks/check_02_system_features.cmake
cmake/macros/macro_check_compiler_setup.cmake
cmake/macros/macro_configure_feature.cmake
cmake/macros/macro_deal_ii_insource_setup_target.cmake
cmake/macros/macro_deal_ii_pickup_tests.cmake
cmake/modules/FindPETSC.cmake
cmake/modules/FindSLEPC.cmake
cmake/modules/FindTRILINOS.cmake
cmake/setup_cached_variables.cmake
cmake/setup_compiler_flags_intel.cmake
doc/developers/testsuite.html
doc/doxygen/CMakeLists.txt
examples/CMakeLists.txt
examples/step-14/step-14.cc
examples/step-21/step-21.cc
examples/step-23/step-23.cc
examples/step-24/step-24.cc
examples/step-26/step-26.cc
examples/step-28/step-28.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-41/step-41.cc
examples/step-42/step-42.cc
examples/step-43/step-43.cc
examples/step-44/step-44.cc
examples/step-45/step-45.cc
examples/step-47/step-47.cc
examples/step-49/step-49.cc
examples/step-50/step-50.cc
examples/step-54/step-54.cc
examples/step-9/step-9.cc
include/deal.II/base/aligned_vector.h
include/deal.II/base/exceptions.h
include/deal.II/base/function_cspline.h
include/deal.II/base/logstream.h
include/deal.II/base/mpi.h
include/deal.II/base/mpi.templates.h
include/deal.II/base/numbers.h
include/deal.II/base/tensor_accessors.h
include/deal.II/base/timer.h
include/deal.II/base/work_stream.h
include/deal.II/dofs/dof_accessor.h
include/deal.II/dofs/dof_accessor.templates.h
include/deal.II/fe/mapping_q_generic.h
include/deal.II/grid/filtered_iterator.h
include/deal.II/grid/grid_tools.h
include/deal.II/grid/manifold.h
include/deal.II/hp/dof_handler.h
include/deal.II/integrators/l2.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_vector_base.h
include/deal.II/lac/diagonal_matrix.h
include/deal.II/lac/exceptions.h
include/deal.II/lac/lapack_full_matrix.h
include/deal.II/lac/lapack_support.h
include/deal.II/lac/solver_bicgstab.h
include/deal.II/lac/swappable_vector.h
include/deal.II/lac/swappable_vector.templates.h
include/deal.II/lac/vector_memory.h
include/deal.II/matrix_free/shape_info.h
include/deal.II/matrix_free/shape_info.templates.h
include/deal.II/meshworker/assembler.h
include/deal.II/meshworker/functional.h
include/deal.II/numerics/derivative_approximation.h
include/deal.II/numerics/error_estimator.templates.h
include/deal.II/numerics/fe_field_function.templates.h
include/deal.II/opencascade/boundary_lib.h
include/deal.II/opencascade/utilities.h
source/base/convergence_table.cc
source/base/function_cspline.cc
source/base/logstream.cc
source/base/mpi.cc
source/base/path_search.cc
source/base/table_handler.cc
source/base/tensor_product_polynomials_bubbles.cc
source/base/timer.cc
source/base/utilities.cc
source/distributed/shared_tria.cc
source/distributed/tria.cc
source/dofs/dof_tools_constraints.cc
source/dofs/dof_tools_constraints.inst.in
source/fe/fe_enriched.cc
source/fe/fe_q_bubbles.inst.in
source/fe/fe_system.cc
source/fe/fe_tools_extrapolate.cc
source/fe/fe_tools_interpolate.cc
source/fe/fe_tools_interpolate.inst.in
source/grid/grid_tools.inst.in
source/grid/manifold.cc
source/grid/tria.cc
source/lac/CMakeLists.txt
source/lac/block_sparsity_pattern.cc
source/lac/lapack_full_matrix.cc
source/lac/petsc_parallel_sparse_matrix.cc
source/lac/petsc_parallel_vector.cc
source/lac/petsc_precondition.cc
source/lac/petsc_vector_base.cc
source/lac/sparsity_pattern.cc
source/lac/trilinos_block_sparse_matrix.cc
source/lac/trilinos_epetra_vector.cc
source/lac/trilinos_precondition_ml.cc
source/lac/trilinos_precondition_muelu.cc
source/lac/trilinos_vector.cc
source/lac/vector_memory.cc
source/lac/vector_memory_release.inst.in
source/numerics/data_out_rotation.cc
source/numerics/derivative_approximation.cc
source/numerics/derivative_approximation.inst.in
source/numerics/time_dependent.cc
source/opencascade/CMakeLists.txt
source/opencascade/boundary_lib.cc
tests/base/aligned_vector_05.cc
tests/base/functions_cspline_02.cc
tests/base/quadrature_chebyshev.cc
tests/base/vectorization_07.cc
tests/bits/count_dofs_per_block_01.cc
tests/bits/count_dofs_per_block_02.cc
tests/bits/face_interpolation.cc
tests/bits/faceq_face_interpolation.cc
tests/bits/faceq_subface_interpolation.cc
tests/bits/fe_tools_02.cc
tests/bits/fe_tools_03.cc
tests/bits/fe_tools_04.cc
tests/bits/fe_tools_05.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_common.h
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/subface_interpolation.cc
tests/build_tests/CMakeLists.txt
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_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_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_common.h
tests/dofs/dof_tools_periodic.h
tests/dofs/hp_constraints_are_implemented.cc
tests/dofs/n_dofs_per_object.cc
tests/fail/rt_crash_01.cc
tests/fe/fe_enriched_step-36.cc
tests/fe/fe_enriched_step-36b.cc
tests/fe/fe_nedelec_hessian_divergence_theorem.cc
tests/fe/fe_prolongation_q_bubbles.cc
tests/fe/fe_q_bubbles.cc
tests/fe/fe_restriction_q_bubbles.cc
tests/fe/fe_support_points_q_bubbles.cc
tests/fe/get_dof_association.cc
tests/fe/interpolate_q_bubbles.cc
tests/fe/q_bubbles_projection_01.cc
tests/fe/restrict_prolongation_01.cc
tests/fe/shapes_q_bubbles.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_common.h
tests/grid/grid_out_per_processor_vtu_02.cc
tests/grid/grid_transform_02.cc
tests/grid/grid_transform_3d.cc
tests/grid/grid_transform_coefficient.cc
tests/hp/count_dofs_per_block_01.cc
tests/hp/count_dofs_per_block_02.cc
tests/hp/create_laplace_matrix_01.cc
tests/hp/create_laplace_matrix_01b.cc
tests/hp/create_laplace_matrix_02.cc
tests/hp/create_laplace_matrix_02b.cc
tests/hp/distribute_dofs_linear_time.cc
tests/integrators/elasticity_01.cc
tests/integrators/grad_div_01.cc
tests/lac/linear_operator_08.cc
tests/lac/vector_operations_parallel_for_start_end.cc
tests/lac/vector_operations_parallel_reduce_start_end.cc
tests/lapack/full_matrix_13.cc
tests/lapack/full_matrix_14.cc
tests/mappings/mapping_q_generic_cell_cache.cc
tests/matrix_free/copy_feevaluation.cc
tests/matrix_free/inverse_mass_01.cc
tests/matrix_free/matrix_vector_20.cc
tests/matrix_free/matrix_vector_21.cc
tests/matrix_free/matrix_vector_common.h
tests/mpi/data_out_hdf5_01.cc
tests/mpi/distort_random_01.cc
tests/mpi/distort_random_02.cc
tests/mpi/distribute_flux_sparsity_pattern.cc
tests/mpi/fe_field_function_03.cc
tests/mpi/no_flux_constraints_02.cc
tests/mpi/no_flux_constraints_03.cc
tests/multigrid/dof_05.cc
tests/multigrid/mg_coarse_01.cc
tests/multigrid/step-16-04.cc
tests/multigrid/step-16-05.cc
tests/multigrid/step-16-06.cc
tests/multigrid/step-50_01.cc
tests/multigrid/transfer_matrix_free_08.cc
tests/numerics/create_mass_matrix_05.cc
tests/numerics/data_out_01.cc
tests/numerics/data_out_02.cc
tests/numerics/data_out_03.cc
tests/numerics/data_out_04.cc
tests/numerics/data_out_05.cc
tests/numerics/data_out_06.cc
tests/numerics/data_out_07.cc
tests/numerics/data_out_08.cc
tests/numerics/data_out_common.h
tests/numerics/data_out_faces_01.cc
tests/numerics/data_out_faces_02.cc
tests/numerics/data_out_faces_03.cc
tests/numerics/data_out_faces_04.cc
tests/numerics/data_out_faces_05.cc
tests/numerics/data_out_multi_dh_01.cc
tests/numerics/data_out_multi_dh_02.cc
tests/numerics/data_out_multi_dh_03.cc
tests/numerics/data_out_multi_dh_04.cc
tests/numerics/data_out_multi_dh_05.cc
tests/numerics/data_out_rotation_01.cc
tests/numerics/data_out_rotation_02.cc
tests/numerics/data_out_rotation_03.cc
tests/numerics/data_out_rotation_04.cc
tests/numerics/data_out_rotation_05.cc
tests/numerics/data_out_stack_01.cc
tests/numerics/data_out_stack_02.cc
tests/numerics/derivative_approximation_01.cc
tests/numerics/derivative_approximation_02.cc
tests/opencascade/circle_normal_projection.cc
tests/opencascade/closest_point_to_shape.cc
tests/parameter_handler/parameter_handler_3_with_space.cc
tests/physics/elasticity-kinematics_02.cc
tests/slepc/solve_04.cc
tests/slepc_complex/00.cc
tests/tests.h
tests/trilinos/block_vector_iterator_03.cc
tests/trilinos/elide_zeros.cc
tests/trilinos/renumbering_01.cc
tests/trilinos/sparse_matrix_mmult_01.cc

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

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.