From: David Wells Date: Sun, 10 Sep 2017 01:02:25 +0000 (-0400) Subject: Remove methods that were never implemented. X-Git-Tag: v9.0.0-rc1~854^2~5 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=575d01080b795839308255419f16b3b3f6438c63;p=dealii.git Remove methods that were never implemented. These were caught by MSVC warning 4661. --- diff --git a/include/deal.II/algorithms/theta_timestepping.h b/include/deal.II/algorithms/theta_timestepping.h index e150f392cd..65d94d5b58 100644 --- a/include/deal.II/algorithms/theta_timestepping.h +++ b/include/deal.II/algorithms/theta_timestepping.h @@ -236,10 +236,7 @@ namespace Algorithms * The current time in the timestepping scheme. */ double current_time() const; - /** - * The current step size. - */ - double step_size() const; + /** * The weight between implicit and explicit part. */ diff --git a/include/deal.II/base/qprojector.h b/include/deal.II/base/qprojector.h index a8a24255eb..f20b517643 100644 --- a/include/deal.II/base/qprojector.h +++ b/include/deal.II/base/qprojector.h @@ -412,11 +412,6 @@ template <> Quadrature<1> QProjector<1>::project_to_all_subfaces (const Quadrature<0> &quadrature); - -template <> -bool -QIterated<1>::uses_both_endpoints (const Quadrature<1> &base_quadrature); - template <> QIterated<1>::QIterated (const Quadrature<1> &base_quadrature, const unsigned int n_copies); diff --git a/include/deal.II/fe/fe_dg_vector.h b/include/deal.II/fe/fe_dg_vector.h index 9d6384ebf3..6941173213 100644 --- a/include/deal.II/fe/fe_dg_vector.h +++ b/include/deal.II/fe/fe_dg_vector.h @@ -92,25 +92,6 @@ private: static std::vector get_dpo_vector (const unsigned int degree); - /** - * Initialize the @p generalized_support_points field of the FiniteElement - * class and fill the tables with @p interior_weights. Called from the - * constructor. - * - * See the - * @ref GlossGeneralizedSupport "glossary entry on generalized support points" - * for more information. - */ - void initialize_support_points (const unsigned int degree); - - /** - * Initialize the interpolation from functions on refined mesh cells onto - * the father cell. According to the philosophy of the Raviart-Thomas - * element, this restriction operator preserves the divergence of a function - * weakly. - */ - void initialize_restriction (); - /** * Fields of cell-independent data. * diff --git a/include/deal.II/fe/fe_dgp_monomial.h b/include/deal.II/fe/fe_dgp_monomial.h index 09df3a3fa1..2a7ff40314 100644 --- a/include/deal.II/fe/fe_dgp_monomial.h +++ b/include/deal.II/fe/fe_dgp_monomial.h @@ -447,11 +447,6 @@ private: */ static std::vector get_dpo_vector (const unsigned int degree); - /** - * Initialize the embedding matrices. Called from the constructor. - */ - void initialize_embedding (); - /** * Initialize the restriction matrices. Called from the constructor. */ diff --git a/include/deal.II/fe/fe_q.h b/include/deal.II/fe/fe_q.h index e41b0130b0..d55171425f 100644 --- a/include/deal.II/fe/fe_q.h +++ b/include/deal.II/fe/fe_q.h @@ -571,14 +571,6 @@ public: */ FE_Q (const Quadrature<1> &points); - /** - * Construct a FE_Q_isoQ1 element. That element shares large parts of code - * with FE_Q so most of the construction work is done in this routine, - * whereas the public constructor is in the class FE_Q_isoQ1. - */ - FE_Q(const unsigned int subdivisions_per_dimension, - const unsigned int base_degree); - /** * Return a string that uniquely identifies a finite element. This class * returns FE_Q(degree), with @p dim and @p degree replaced by diff --git a/include/deal.II/grid/tria.h b/include/deal.II/grid/tria.h index 6e552172ac..4fab22e2b0 100644 --- a/include/deal.II/grid/tria.h +++ b/include/deal.II/grid/tria.h @@ -3086,17 +3086,6 @@ public: */ unsigned int n_raw_quads (const unsigned int level) const; - /** - * Total number of hexs, used or unused. - * - * @note This function really exports internal information about the - * triangulation. It shouldn't be used in applications. The function is only - * part of the public interface of this class because it is used in some of - * the other classes that build very closely on it (in particular, the - * DoFHandler class). - */ - unsigned int n_raw_hexs () const; - /** * Number of hexs, used or unused, on the given level. * diff --git a/include/deal.II/lac/block_vector.h b/include/deal.II/lac/block_vector.h index ee0a89e293..94a43d013f 100644 --- a/include/deal.II/lac/block_vector.h +++ b/include/deal.II/lac/block_vector.h @@ -309,13 +309,6 @@ public: */ void swap (BlockVector &v); - /** - * Output of vector in user-defined format. - * - * This function is deprecated. - */ - void print (const char *format = nullptr) const DEAL_II_DEPRECATED; - /** * Print to a stream. */ diff --git a/include/deal.II/lac/chunk_sparse_matrix.h b/include/deal.II/lac/chunk_sparse_matrix.h index 0f9b773f3c..f9af644ca8 100644 --- a/include/deal.II/lac/chunk_sparse_matrix.h +++ b/include/deal.II/lac/chunk_sparse_matrix.h @@ -801,12 +801,6 @@ public: */ number diag_element (const size_type i) const; - /** - * Same as above, but return a writeable reference. You're sure you know - * what you do? - */ - number &diag_element (const size_type i); - /** * Extracts a copy of the values and indices in the given matrix row. * diff --git a/include/deal.II/lac/precondition_block.h b/include/deal.II/lac/precondition_block.h index aa83f867b4..e27a9ef1dd 100644 --- a/include/deal.II/lac/precondition_block.h +++ b/include/deal.II/lac/precondition_block.h @@ -457,11 +457,6 @@ public: */ const_iterator &operator++ (); - /** - * Postfix increment. - */ - const_iterator &operator++ (int); - /** * Dereferencing operator. */ @@ -502,7 +497,6 @@ public: using PreconditionBlock::clear; using PreconditionBlock::empty; using PreconditionBlock::el; - using PreconditionBlock::set_same_diagonal; using PreconditionBlock::invert_diagblocks; using PreconditionBlock::block_size; using PreconditionBlockBase::size; @@ -655,13 +649,10 @@ public: using typename PreconditionBlock::AdditionalData; using PreconditionBlock::initialize; using PreconditionBlock::clear; - using PreconditionBlock::empty; using PreconditionBlockBase::size; using PreconditionBlockBase::inverse; using PreconditionBlockBase::inverse_householder; using PreconditionBlockBase::inverse_svd; - using PreconditionBlock::el; - using PreconditionBlock::set_same_diagonal; using PreconditionBlock::invert_diagblocks; using PreconditionBlock::set_permutation; using PreconditionBlockBase::log_statistics; @@ -827,7 +818,6 @@ public: using PreconditionBlockSOR::set_permutation; using PreconditionBlockSOR::empty; using PreconditionBlockSOR::el; - using PreconditionBlockSOR::set_same_diagonal; using PreconditionBlockSOR::invert_diagblocks; /** diff --git a/include/deal.II/lac/precondition_block_base.h b/include/deal.II/lac/precondition_block_base.h index 9953ddf528..06fb417ec8 100644 --- a/include/deal.II/lac/precondition_block_base.h +++ b/include/deal.II/lac/precondition_block_base.h @@ -109,16 +109,6 @@ public: */ void inverses_computed(bool are_they); - /** - * Use only the inverse of the first diagonal block to save memory and - * computation time. - * - * Possible applications: computing on a cartesian grid, all diagonal blocks - * are the same or all diagonal blocks are at least similar and inversion of - * one of them still yields a preconditioner. - */ - void set_same_diagonal (); - /** * Does the matrix use only one diagonal block? */ @@ -134,22 +124,11 @@ public: */ bool inverses_ready () const; - /** - * Check whether the object is empty. - */ - bool empty () const; - /** * The number of blocks. */ unsigned int size() const; - /** - * Read-only access to entries. This function is only possible if the - * inverse diagonal blocks are stored. - */ - number el(size_type i, size_type j) const; - /** * Multiply with the inverse block at position i. */ diff --git a/include/deal.II/lac/relaxation_block.h b/include/deal.II/lac/relaxation_block.h index f142cb6678..ae51802cc4 100644 --- a/include/deal.II/lac/relaxation_block.h +++ b/include/deal.II/lac/relaxation_block.h @@ -193,18 +193,6 @@ public: */ void clear(); - /** - * Check whether the object is empty. - */ - bool empty () const; - - /** - * Read-only access to entries. This function is only possible if the - * inverse diagonal blocks are stored. - */ - value_type el(size_type i, - size_type j) const; - /** * Stores the inverse of the diagonal blocks in @p inverse. This costs some * additional memory - for DG methods about 1/3 (for double inverses) or 1/6 @@ -305,10 +293,6 @@ public: */ using RelaxationBlock::clear; - /** - * Make function of base class public again. - */ - using RelaxationBlock::empty; /** * Make function of base class public again. */ @@ -350,11 +334,6 @@ public: * the dst() vector to zero before calling the Tstep() method. */ void Tvmult (VectorType &dst, const VectorType &rhs) const; - - /** - * Return the memory allocated in this object. - */ - std::size_t memory_consumption() const; }; @@ -405,10 +384,6 @@ public: */ using RelaxationBlock::clear; - /** - * Make function of base class public again. - */ - using RelaxationBlock::empty; /** * Make function of base class public again. */ @@ -495,11 +470,6 @@ public: */ using RelaxationBlock::clear; - /** - * Make function of base class public again. - */ - using RelaxationBlock::empty; - /** * Make function of base class public again. */ diff --git a/include/deal.II/lac/sparse_matrix_ez.h b/include/deal.II/lac/sparse_matrix_ez.h index cf146636d6..94a113ee64 100644 --- a/include/deal.II/lac/sparse_matrix_ez.h +++ b/include/deal.II/lac/sparse_matrix_ez.h @@ -245,11 +245,6 @@ public: */ const_iterator &operator++ (); - /** - * Postfix increment. This always returns a valid entry or end(). - */ - const_iterator &operator++ (int); - /** * Dereferencing operator. */ diff --git a/include/deal.II/lac/tridiagonal_matrix.h b/include/deal.II/lac/tridiagonal_matrix.h index 81ce9731ee..c1ab61fa06 100644 --- a/include/deal.II/lac/tridiagonal_matrix.h +++ b/include/deal.II/lac/tridiagonal_matrix.h @@ -187,41 +187,6 @@ public: number matrix_norm_square (const Vector &v) const; //@} -///@name Matrixnorms -//@{ - - /** - * Return the $l_1$-norm of the matrix, i.e. $|M|_1=max_{all columns - * j}\sum_{all rows i} |M_ij|$, (max. sum of columns). This is the natural - * matrix norm that is compatible to the $l_1$-norm for vectors, i.e. - * $|Mv|_1\leq |M|_1 |v|_1$. (cf. Rannacher Numerik0) - */ - number l1_norm () const; - - /** - * Return the $l_\infty$-norm of the matrix, i.e. $|M|_\infty=\max_{all rows - * i}\sum_{all columns j} |M_{ij}|$, (max. sum of rows). This is the natural - * matrix norm that is compatible to the $l_\infty$-norm of vectors, i.e. - * $|Mv|_\infty \leq |M|_\infty |v|_\infty$. - */ - number linfty_norm () const; - - /** - * The Frobenius norm of the matrix. Return value is the root of the square - * sum of all matrix entries. - */ - number frobenius_norm () const; - - /** - * Compute the relative norm of the skew-symmetric part. The return value is - * the Frobenius norm of the skew-symmetric part of the matrix divided by - * that of the matrix. - * - * Main purpose of this function is to check, if a matrix is symmetric - * within a certain accuracy, or not. - */ - number relative_symmetry_norm2 () const; -//@} ///@name LAPACK operations //@{ /** @@ -246,13 +211,6 @@ public: const unsigned int width=5, const unsigned int precision=2) const; - /** - * Determine an estimate for the memory consumption (in bytes) of this - * object. - */ - std::size_t memory_consumption () const; - //@} - private: /** * The diagonal entries. diff --git a/include/deal.II/meshworker/dof_info.h b/include/deal.II/meshworker/dof_info.h index 4c70709f5b..af78c3e5ce 100644 --- a/include/deal.II/meshworker/dof_info.h +++ b/include/deal.II/meshworker/dof_info.h @@ -233,11 +233,6 @@ namespace MeshWorker template void assemble(ASSEMBLER &ass) const; - /** - * The memory used by this object. - */ - std::size_t memory_consumption () const; - /** * The data for the cell. diff --git a/include/deal.II/meshworker/local_results.h b/include/deal.II/meshworker/local_results.h index b6071625ce..c23ecf80f0 100644 --- a/include/deal.II/meshworker/local_results.h +++ b/include/deal.II/meshworker/local_results.h @@ -357,14 +357,6 @@ namespace MeshWorker std::size_t memory_consumption () const; private: - /** - * Initialize a single local matrix block. A helper function for - * initialize() - */ - void initialize_local(MatrixBlock > &M, - const unsigned int row, - const unsigned int col); - /** * The local numbers, computed on a cell or on a face. */ diff --git a/include/deal.II/meshworker/vector_selector.h b/include/deal.II/meshworker/vector_selector.h index 14078ad2e2..86e461ee87 100644 --- a/include/deal.II/meshworker/vector_selector.h +++ b/include/deal.II/meshworker/vector_selector.h @@ -268,10 +268,6 @@ namespace MeshWorker const unsigned int start, const unsigned int size) const; - /** - * The memory used by this object. - */ - std::size_t memory_consumption () const; protected: AnyData data; }; @@ -380,12 +376,6 @@ namespace MeshWorker * reasonable data before calling this function. */ void initialize(const MGLevelObject *, const std::string &name); - - - /** - * The memory used by this object. - */ - std::size_t memory_consumption () const; }; diff --git a/include/deal.II/numerics/data_out_stack.h b/include/deal.II/numerics/data_out_stack.h index 5563f3d4f9..43c1b01520 100644 --- a/include/deal.II/numerics/data_out_stack.h +++ b/include/deal.II/numerics/data_out_stack.h @@ -244,11 +244,6 @@ public: */ void finish_parameter_value (); - /** - * Clear all data presently stored in this object. - */ - void clear (); - /** * Determine an estimate for the memory consumption (in bytes) of this * object.