]> https://gitweb.dealii.org/ - dealii.git/commit
Make sure to use override where appropriate
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Wed, 9 May 2018 14:58:09 +0000 (16:58 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Wed, 9 May 2018 20:10:41 +0000 (22:10 +0200)
commit0e12f6f87a0b84fadd8df629f55da42a8494ce8f
treef97cda614ac348fabfe0dc6bd32cf9433287ab97
parentead0a02532f1380c5eed75857012a003161dadc3
Make sure to use override where appropriate
183 files changed:
bundled/muparser_v2_2_4/include/muParser.h
bundled/muparser_v2_2_4/include/muParserBase.h
bundled/muparser_v2_2_4/include/muParserInt.h
examples/step-12/step-12.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-17/step-17.cc
examples/step-18/step-18.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-29/step-29.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-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-41/step-41.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-50/step-50.cc
examples/step-51/step-51.cc
examples/step-55/step-55.cc
examples/step-56/step-56.cc
examples/step-57/step-57.cc
examples/step-7/step-7.cc
examples/step-9/step-9.cc
include/deal.II/algorithms/newton.h
include/deal.II/algorithms/operator.h
include/deal.II/algorithms/theta_timestepping.h
include/deal.II/base/aligned_vector.h
include/deal.II/base/auto_derivative_function.h
include/deal.II/base/data_out_base.h
include/deal.II/base/exceptions.h
include/deal.II/base/flow_function.h
include/deal.II/base/function.h
include/deal.II/base/function_bessel.h
include/deal.II/base/function_cspline.h
include/deal.II/base/function_derivative.h
include/deal.II/base/function_lib.h
include/deal.II/base/function_parser.h
include/deal.II/base/function_spherical.h
include/deal.II/base/logstream.h
include/deal.II/base/parameter_acceptor.h
include/deal.II/base/parameter_handler.h
include/deal.II/base/parsed_function.h
include/deal.II/base/partitioner.h
include/deal.II/base/patterns.h
include/deal.II/base/quadrature.h
include/deal.II/base/quadrature_point_data.h
include/deal.II/base/table.h
include/deal.II/base/tensor_function.h
include/deal.II/base/thread_management.h
include/deal.II/base/time_stepping.h
include/deal.II/base/work_stream.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/dof_handler.h
include/deal.II/dofs/dof_handler_policy.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_bernstein.h
include/deal.II/fe/fe_dg_vector.h
include/deal.II/fe/fe_dgp.h
include/deal.II/fe/fe_dgp_monomial.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_face.h
include/deal.II/fe/fe_nedelec.h
include/deal.II/fe/fe_nedelec_sz.h
include/deal.II/fe/fe_p1nc.h
include/deal.II/fe/fe_poly.h
include/deal.II/fe/fe_poly_face.h
include/deal.II/fe/fe_poly_tensor.h
include/deal.II/fe/fe_q.h
include/deal.II/fe/fe_q_base.h
include/deal.II/fe/fe_q_bubbles.h
include/deal.II/fe/fe_q_dg0.h
include/deal.II/fe/fe_q_hierarchical.h
include/deal.II/fe/fe_q_iso_q1.h
include/deal.II/fe/fe_rannacher_turek.h
include/deal.II/fe/fe_raviart_thomas.h
include/deal.II/fe/fe_system.h
include/deal.II/fe/fe_tools.h
include/deal.II/fe/fe_trace.h
include/deal.II/fe/fe_values.h
include/deal.II/grid/grid_tools_cache.h
include/deal.II/grid/manifold.h
include/deal.II/grid/persistent_tria.h
include/deal.II/grid/tria.h
include/deal.II/hp/dof_handler.h
include/deal.II/lac/block_matrix_base.h
include/deal.II/lac/block_sparse_matrix.h
include/deal.II/lac/block_sparsity_pattern.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/chunk_sparsity_pattern.h
include/deal.II/lac/exceptions.h
include/deal.II/lac/matrix_out.h
include/deal.II/lac/petsc_full_matrix.h
include/deal.II/lac/petsc_matrix_base.h
include/deal.II/lac/petsc_matrix_free.h
include/deal.II/lac/petsc_parallel_block_sparse_matrix.h
include/deal.II/lac/petsc_parallel_block_vector.h
include/deal.II/lac/petsc_parallel_sparse_matrix.h
include/deal.II/lac/petsc_parallel_vector.h
include/deal.II/lac/petsc_solver.h
include/deal.II/lac/petsc_sparse_matrix.h
include/deal.II/lac/petsc_vector_base.h
include/deal.II/lac/pointer_matrix.h
include/deal.II/lac/precondition.h
include/deal.II/lac/precondition_block.h
include/deal.II/lac/precondition_selector.h
include/deal.II/lac/read_write_vector.h
include/deal.II/lac/scalapack.h
include/deal.II/lac/solver_bicgstab.h
include/deal.II/lac/solver_cg.h
include/deal.II/lac/solver_control.h
include/deal.II/lac/solver_minres.h
include/deal.II/lac/solver_richardson.h
include/deal.II/lac/solver_selector.h
include/deal.II/lac/sparse_decomposition.h
include/deal.II/lac/sparse_direct.h
include/deal.II/lac/sparse_ilu.h
include/deal.II/lac/sparse_matrix.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/sparse_mic.h
include/deal.II/lac/sparsity_pattern.h
include/deal.II/lac/swappable_vector.h
include/deal.II/lac/trilinos_block_sparse_matrix.h
include/deal.II/lac/trilinos_epetra_communication_pattern.h
include/deal.II/lac/trilinos_parallel_block_vector.h
include/deal.II/lac/trilinos_precondition.h
include/deal.II/lac/trilinos_sparse_matrix.h
include/deal.II/lac/trilinos_sparsity_pattern.h
include/deal.II/lac/trilinos_vector.h
include/deal.II/lac/vector.h
include/deal.II/lac/vector_memory.h
include/deal.II/lac/vector_view.h
include/deal.II/matrix_free/matrix_free.h
include/deal.II/matrix_free/operators.h
include/deal.II/meshworker/local_integrator.h
include/deal.II/meshworker/vector_selector.h
include/deal.II/multigrid/mg_base.h
include/deal.II/multigrid/mg_coarse.h
include/deal.II/multigrid/mg_matrix.h
include/deal.II/multigrid/mg_smoother.h
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer_block.h
include/deal.II/multigrid/mg_transfer_component.h
include/deal.II/multigrid/mg_transfer_matrix_free.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_stack.h
include/deal.II/numerics/data_postprocessor.h
include/deal.II/numerics/dof_output_operator.h
include/deal.II/numerics/dof_output_operator.templates.h
include/deal.II/numerics/fe_field_function.h
include/deal.II/numerics/time_dependent.h
include/deal.II/particles/particle_handler.h
source/base/logstream.cc
source/fe/fe_values.cc
source/fe/fe_values.decl.2.inst.in
source/lac/trilinos_solver.cc
source/matrix_free/task_info.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.