]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove methods that were never implemented.
authorDavid Wells <wellsd2@rpi.edu>
Sun, 10 Sep 2017 01:02:25 +0000 (21:02 -0400)
committerDavid Wells <wellsd2@rpi.edu>
Sat, 28 Oct 2017 18:15:53 +0000 (14:15 -0400)
These were caught by MSVC warning 4661.

17 files changed:
include/deal.II/algorithms/theta_timestepping.h
include/deal.II/base/qprojector.h
include/deal.II/fe/fe_dg_vector.h
include/deal.II/fe/fe_dgp_monomial.h
include/deal.II/fe/fe_q.h
include/deal.II/grid/tria.h
include/deal.II/lac/block_vector.h
include/deal.II/lac/chunk_sparse_matrix.h
include/deal.II/lac/precondition_block.h
include/deal.II/lac/precondition_block_base.h
include/deal.II/lac/relaxation_block.h
include/deal.II/lac/sparse_matrix_ez.h
include/deal.II/lac/tridiagonal_matrix.h
include/deal.II/meshworker/dof_info.h
include/deal.II/meshworker/local_results.h
include/deal.II/meshworker/vector_selector.h
include/deal.II/numerics/data_out_stack.h

index e150f392cdf993bf1f588dc21ab3613a319d4132..65d94d5b589952f0282be175791888e92dae1f6d 100644 (file)
@@ -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.
      */
index a8a24255eb483da80762e2db1433a46df608c6f2..f20b517643d42afec3440715385cc77953d705b9 100644 (file)
@@ -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);
index 9d6384ebf3a6f0015cd97a5b7201ecd09c8c9061..694117321355ead231838551d407973316371d78 100644 (file)
@@ -92,25 +92,6 @@ private:
   static std::vector<unsigned int>
   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.
    *
index 09df3a3fa1cf6bcc6b12bd930edbadab36df016a..2a7ff40314a9732965fd2f9775fe7f736bd05496 100644 (file)
@@ -447,11 +447,6 @@ private:
    */
   static std::vector<unsigned int> 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.
    */
index e41b0130b07e7cef58fa79a8f21426a31a35b0ad..d55171425f0bc5c9dfca7dccaab94e5bde546dd7 100644 (file)
@@ -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 <tt>FE_Q<dim>(degree)</tt>, with @p dim and @p degree replaced by
index 6e552172ac20f8ff5dff9a3b7f1c525eb157f3d2..4fab22e2b0f352142bdaf53ea58dabccc54f34ca 100644 (file)
@@ -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.
    *
index ee0a89e293bf3c780aa7e4074e3415b224d46176..94a43d013f44b600363d74a7c015b9030f8e6a75 100644 (file)
@@ -309,13 +309,6 @@ public:
    */
   void swap (BlockVector<Number> &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.
    */
index 0f9b773f3cee8ce4681a06306af1f9b05df99553..f9af644ca86ba7fc14a6b263abc57019635b430e 100644 (file)
@@ -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.
    *
index aa83f867b4bb92c17024b757a8fec48a1f28cb61..e27a9ef1dd947421faaf5ce5c78a74eccdfbc171 100644 (file)
@@ -457,11 +457,6 @@ public:
      */
     const_iterator &operator++ ();
 
-    /**
-     * Postfix increment.
-     */
-    const_iterator &operator++ (int);
-
     /**
      * Dereferencing operator.
      */
@@ -502,7 +497,6 @@ public:
   using PreconditionBlock<MatrixType, inverse_type>::clear;
   using PreconditionBlock<MatrixType, inverse_type>::empty;
   using PreconditionBlock<MatrixType, inverse_type>::el;
-  using PreconditionBlock<MatrixType, inverse_type>::set_same_diagonal;
   using PreconditionBlock<MatrixType, inverse_type>::invert_diagblocks;
   using PreconditionBlock<MatrixType, inverse_type>::block_size;
   using PreconditionBlockBase<inverse_type>::size;
@@ -655,13 +649,10 @@ public:
   using typename PreconditionBlock<MatrixType,inverse_type>::AdditionalData;
   using PreconditionBlock<MatrixType, inverse_type>::initialize;
   using PreconditionBlock<MatrixType, inverse_type>::clear;
-  using PreconditionBlock<MatrixType, inverse_type>::empty;
   using PreconditionBlockBase<inverse_type>::size;
   using PreconditionBlockBase<inverse_type>::inverse;
   using PreconditionBlockBase<inverse_type>::inverse_householder;
   using PreconditionBlockBase<inverse_type>::inverse_svd;
-  using PreconditionBlock<MatrixType, inverse_type>::el;
-  using PreconditionBlock<MatrixType, inverse_type>::set_same_diagonal;
   using PreconditionBlock<MatrixType, inverse_type>::invert_diagblocks;
   using PreconditionBlock<MatrixType, inverse_type>::set_permutation;
   using PreconditionBlockBase<inverse_type>::log_statistics;
@@ -827,7 +818,6 @@ public:
   using PreconditionBlockSOR<MatrixType,inverse_type>::set_permutation;
   using PreconditionBlockSOR<MatrixType, inverse_type>::empty;
   using PreconditionBlockSOR<MatrixType, inverse_type>::el;
-  using PreconditionBlockSOR<MatrixType,inverse_type>::set_same_diagonal;
   using PreconditionBlockSOR<MatrixType,inverse_type>::invert_diagblocks;
 
   /**
index 9953ddf5282ba4325d6ced6ab04856c9b08845ae..06fb417ec89b7495bc2de5fdf18482c0520a31eb 100644 (file)
@@ -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 <tt>i</tt>.
    */
index f142cb6678681a66a1f751fa4fe137bbe8d7403d..ae51802cc4a79c95172ef0c52ce383a6a05ad460 100644 (file)
@@ -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<MatrixType, InverseNumberType, VectorType>::clear;
 
-  /**
-   * Make function of base class public again.
-   */
-  using RelaxationBlock<MatrixType, InverseNumberType, VectorType>::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<MatrixType, InverseNumberType, VectorType>::clear;
 
-  /**
-   * Make function of base class public again.
-   */
-  using RelaxationBlock<MatrixType, InverseNumberType, VectorType>::empty;
   /**
    * Make function of base class public again.
    */
@@ -495,11 +470,6 @@ public:
    */
   using RelaxationBlock<MatrixType, InverseNumberType, VectorType>::clear;
 
-  /**
-   * Make function of base class public again.
-   */
-  using RelaxationBlock<MatrixType, InverseNumberType, VectorType>::empty;
-
   /**
    * Make function of base class public again.
    */
index cf146636d613ee4a04f0e58021968e389f1d1bd7..94a113ee64d9696e506a67e3cf7a7c228c763127 100644 (file)
@@ -245,11 +245,6 @@ public:
      */
     const_iterator &operator++ ();
 
-    /**
-     * Postfix increment. This always returns a valid entry or <tt>end()</tt>.
-     */
-    const_iterator &operator++ (int);
-
     /**
      * Dereferencing operator.
      */
index 81ce9731eed419d025ab4a471b8f89006f94ca9c..c1ab61fa0607370dca4511b710281437552671f4 100644 (file)
@@ -187,41 +187,6 @@ public:
   number matrix_norm_square (const Vector<number> &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.
index 4c70709f5bd149d42ae5c84dae636116be9da4ee..af78c3e5ce7fb1077f63922678782c62dadf1a61 100644 (file)
@@ -233,11 +233,6 @@ namespace MeshWorker
     template <class ASSEMBLER>
     void assemble(ASSEMBLER &ass) const;
 
-    /**
-     * The memory used by this object.
-     */
-    std::size_t memory_consumption () const;
-
 
     /**
      * The data for the cell.
index b6071625ce8f0acb21cd342568757a67d1e6489d..c23ecf80f047d6f14c5fa357d84675113c84ea4b 100644 (file)
@@ -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<FullMatrix<number> > &M,
-                          const unsigned int row,
-                          const unsigned int col);
-
     /**
      * The local numbers, computed on a cell or on a face.
      */
index 14078ad2e2d1afd71c2d0838bb5baa9fe8256c7d..86e461ee878fee492094e10f7af951970f15f2dd 100644 (file)
@@ -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<VectorType> *, const std::string &name);
-
-
-    /**
-     * The memory used by this object.
-     */
-    std::size_t memory_consumption () const;
   };
 
 
index 5563f3d4f960ab9b874e067093f8f306f2c1dd22..43c1b01520dbbdc2cd81f2953d8c629b973b6d84 100644 (file)
@@ -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.

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.