Sort all includes in src/gromacs
[alexxy/gromacs.git] / src / gromacs / options / optionsassigner.cpp
index 6019fbd5b1c268c66685334c7e050d4261b1c7e3..df3f1320d89da7ddb54996b610e7c5885d30a614 100644 (file)
@@ -1,50 +1,55 @@
 /*
+ * This file is part of the GROMACS molecular simulation package.
  *
- *                This source code is part of
+ * Copyright (c) 2010,2011,2012,2013,2014, by the GROMACS development team, led by
+ * Mark Abraham, David van der Spoel, Berk Hess, and Erik Lindahl,
+ * and including many others, as listed in the AUTHORS file in the
+ * top-level source directory and at http://www.gromacs.org.
  *
- *                 G   R   O   M   A   C   S
+ * GROMACS is free software; you can redistribute it and/or
+ * modify it under the terms of the GNU Lesser General Public License
+ * as published by the Free Software Foundation; either version 2.1
+ * of the License, or (at your option) any later version.
  *
- *          GROningen MAchine for Chemical Simulations
+ * GROMACS is distributed in the hope that it will be useful,
+ * but WITHOUT ANY WARRANTY; without even the implied warranty of
+ * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the GNU
+ * Lesser General Public License for more details.
  *
- * Written by David van der Spoel, Erik Lindahl, Berk Hess, and others.
- * Copyright (c) 1991-2000, University of Groningen, The Netherlands.
- * Copyright (c) 2001-2009, The GROMACS development team,
- * check out http://www.gromacs.org for more information.
-
- * This program is free software; you can redistribute it and/or
- * modify it under the terms of the GNU General Public License
- * as published by the Free Software Foundation; either version 2
- * of the License, or (at your option) any later version.
+ * You should have received a copy of the GNU Lesser General Public
+ * License along with GROMACS; if not, see
+ * http://www.gnu.org/licenses, or write to the Free Software Foundation,
+ * Inc., 51 Franklin Street, Fifth Floor, Boston, MA  02110-1301  USA.
  *
- * If you want to redistribute modifications, please consider that
- * scientific software is very special. Version control is crucial -
- * bugs must be traceable. We will be happy to consider code for
- * inclusion in the official distribution, but derived work must not
- * be called official GROMACS. Details are found in the README & COPYING
- * files - if they are missing, get the official version at www.gromacs.org.
+ * If you want to redistribute modifications to GROMACS, please
+ * consider that scientific software is very special. Version
+ * control is crucial - bugs must be traceable. We will be happy to
+ * consider code for inclusion in the official distribution, but
+ * derived work must not be called official GROMACS. Details are found
+ * in the README & COPYING files - if they are missing, get the
+ * official version at http://www.gromacs.org.
  *
  * To help us fund GROMACS development, we humbly ask that you cite
- * the papers on the package - you can find them in the top README file.
- *
- * For more info, check our website at http://www.gromacs.org
+ * the research papers on the package. Check out http://www.gromacs.org.
  */
 /*! \internal \file
  * \brief
  * Implements gmx::OptionsAssigner.
  *
- * \author Teemu Murtola <teemu.murtola@cbr.su.se>
+ * \author Teemu Murtola <teemu.murtola@gmail.com>
  * \ingroup module_options
  */
-#include "gromacs/options/optionsassigner.h"
+#include "gmxpre.h"
+
+#include "optionsassigner.h"
 
 #include <deque>
 
-#include "gromacs/fatalerror/exceptions.h"
-#include "gromacs/fatalerror/gmxassert.h"
 #include "gromacs/options/abstractoptionstorage.h"
 #include "gromacs/options/options.h"
+#include "gromacs/utility/exceptions.h"
+#include "gromacs/utility/gmxassert.h"
 
-#include "optionsassigner-impl.h"
 #include "options-impl.h"
 
 namespace gmx
@@ -54,49 +59,90 @@ namespace gmx
  * OptionsAssigner::Impl
  */
 
-OptionsAssigner::Impl::Impl(Options *options)
-    : _options(*options), _flags(0), _currentOption(NULL),
-      _currentValueCount(0), _reverseBoolean(false)
+/*! \internal \brief
+ * Private implementation class for OptionsAssigner.
+ *
+ * \ingroup module_options
+ */
+class OptionsAssigner::Impl
 {
-    _sectionStack.push_back(&_options);
-}
+    public:
+        //! Sets the option object to assign to.
+        explicit Impl(Options *options);
+
+        //! Returns true if a subsection has been set.
+        bool inSubSection() const { return sectionStack_.size() > 1; }
+        //! Returns the Options object for the current section.
+        Options &currentSection() const { return *sectionStack_.back(); }
+        /*! \brief
+         * Finds an option by the given name.
+         *
+         * \param[in] name  Name of the option to look for.
+         * \returns Pointer to the found option, or NULL if none found.
+         *
+         * This function takes into account the flags specified, and may change
+         * the internal state of the assigner to match the option found.
+         * If no option is found, the internal state is not modified.
+         */
+        AbstractOptionStorage *findOption(const char *name);
 
-void OptionsAssigner::Impl::setFlag(OptionsAssigner::Impl::Flag flag, bool bSet)
+        //! Options object to assign to.
+        Options                &options_;
+        //! Recognize boolean option "name" also as "noname".
+        bool                    bAcceptBooleanNoPrefix_;
+        //! Look for options in all sections, not just the current one.
+        bool                    bNoStrictSectioning_;
+        /*! \brief
+         * List of (sub)sections being assigned to.
+         *
+         * The first element always points to \a options_.
+         */
+        std::vector<Options *>  sectionStack_;
+        //! Current option being assigned to, or NULL if none.
+        AbstractOptionStorage  *currentOption_;
+        /*! \brief
+         * Number of values assigned so far to the current option.
+         *
+         * Counts the number of attempted assignments, whether they have been
+         * successful or not.
+         */
+        int                     currentValueCount_;
+        //! If true, a "no" prefix was given for the current boolean option.
+        bool                    reverseBoolean_;
+};
+
+OptionsAssigner::Impl::Impl(Options *options)
+    : options_(*options), bAcceptBooleanNoPrefix_(false),
+      bNoStrictSectioning_(false), currentOption_(NULL),
+      currentValueCount_(0), reverseBoolean_(false)
 {
-    if (bSet)
-    {
-        _flags |= flag;
-    }
-    else
-    {
-        _flags &= ~flag;
-    }
+    sectionStack_.push_back(&options_);
 }
 
 AbstractOptionStorage *
 OptionsAssigner::Impl::findOption(const char *name)
 {
-    GMX_RELEASE_ASSERT(_currentOption == NULL,
+    GMX_RELEASE_ASSERT(currentOption_ == NULL,
                        "Cannot search for another option while processing one");
-    AbstractOptionStorage *option = NULL;
-    Options *section = NULL;
-    Options *root = &currentSection();
-    Options *oldRoot = NULL;
-    int      upcount = 0;
-    std::deque<Options *> searchList;
+    AbstractOptionStorage *option  = NULL;
+    Options               *section = NULL;
+    Options               *root    = &currentSection();
+    Options               *oldRoot = NULL;
+    int                    upcount = 0;
+    std::deque<Options *>  searchList;
     searchList.push_back(root);
     while (option == NULL && !searchList.empty())
     {
         section = searchList.front();
-        option = section->_impl->findOption(name);
-        if (option == NULL && hasFlag(efAcceptBooleanNoPrefix))
+        option  = section->impl_->findOption(name);
+        if (option == NULL && bAcceptBooleanNoPrefix_)
         {
             if (name[0] == 'n' && name[1] == 'o')
             {
-                option = section->_impl->findOption(name + 2);
+                option = section->impl_->findOption(name + 2);
                 if (option != NULL && option->isBoolean())
                 {
-                    _reverseBoolean = true;
+                    reverseBoolean_ = true;
                 }
                 else
                 {
@@ -105,41 +151,41 @@ OptionsAssigner::Impl::findOption(const char *name)
             }
         }
         searchList.pop_front();
-        if (hasFlag(efNoStrictSectioning))
+        if (bNoStrictSectioning_)
         {
             Options::Impl::SubSectionList::const_iterator i;
-            for (i = section->_impl->_subSections.begin();
-                 i != section->_impl->_subSections.end(); ++i)
+            for (i = section->impl_->subSections_.begin();
+                 i != section->impl_->subSections_.end(); ++i)
             {
                 if (*i != oldRoot)
                 {
                     searchList.push_back(*i);
                 }
             }
-            if (searchList.empty() && root != &_options)
+            if (searchList.empty() && root != &options_)
             {
-                root = root->_impl->_parent;
+                root = root->impl_->parent_;
                 ++upcount;
                 searchList.push_back(root);
             }
         }
     }
-    if (hasFlag(efNoStrictSectioning) && option != NULL)
+    if (bNoStrictSectioning_ && option != NULL)
     {
         while (upcount > 0)
         {
-            _sectionStack.pop_back();
+            sectionStack_.pop_back();
             --upcount;
         }
         std::vector<Options *> sections;
         while (section != &currentSection())
         {
             sections.push_back(section);
-            section = section->_impl->_parent;
+            section = section->impl_->parent_;
         }
         while (!sections.empty())
         {
-            _sectionStack.push_back(sections.back());
+            sectionStack_.push_back(sections.back());
             sections.pop_back();
         }
     }
@@ -151,7 +197,7 @@ OptionsAssigner::Impl::findOption(const char *name)
  */
 
 OptionsAssigner::OptionsAssigner(Options *options)
-    : _impl(new Impl(options))
+    : impl_(new Impl(options))
 {
 }
 
@@ -159,74 +205,81 @@ OptionsAssigner::~OptionsAssigner()
 {
 }
 
-void OptionsAssigner::setAcceptBooleanNoPrefix(bool enabled)
+void OptionsAssigner::setAcceptBooleanNoPrefix(bool bEnabled)
 {
-    _impl->setFlag(Impl::efAcceptBooleanNoPrefix, enabled);
+    impl_->bAcceptBooleanNoPrefix_ = bEnabled;
 }
 
-void OptionsAssigner::setNoStrictSectioning(bool enabled)
+void OptionsAssigner::setNoStrictSectioning(bool bEnabled)
 {
-    _impl->setFlag(Impl::efNoStrictSectioning, enabled);
+    impl_->bNoStrictSectioning_ = bEnabled;
 }
 
 void OptionsAssigner::start()
 {
-    _impl->_options._impl->startSource();
+    impl_->options_.impl_->startSource();
 }
 
 void OptionsAssigner::startSubSection(const char *name)
 {
-    Options *section = _impl->currentSection()._impl->findSubSection(name);
+    Options *section = impl_->currentSection().impl_->findSubSection(name);
     if (section == NULL)
     {
         GMX_THROW(InvalidInputError("Unknown subsection"));
     }
-    _impl->_sectionStack.push_back(section);
+    impl_->sectionStack_.push_back(section);
 }
 
 void OptionsAssigner::startOption(const char *name)
 {
-    GMX_RELEASE_ASSERT(_impl->_currentOption == NULL, "finishOption() not called");
-    AbstractOptionStorage *option = _impl->findOption(name);
+    if (!tryStartOption(name))
+    {
+        GMX_THROW(InvalidInputError("Unknown option " + std::string(name)));
+    }
+}
+
+bool OptionsAssigner::tryStartOption(const char *name)
+{
+    GMX_RELEASE_ASSERT(impl_->currentOption_ == NULL, "finishOption() not called");
+    AbstractOptionStorage *option = impl_->findOption(name);
     if (option == NULL)
     {
-        GMX_THROW(InvalidInputError("Unknown option"));
+        return false;
     }
     option->startSet();
-    _impl->_currentOption = option;
-    _impl->_currentValueCount = 0;
+    impl_->currentOption_     = option;
+    impl_->currentValueCount_ = 0;
+    return true;
 }
 
 void OptionsAssigner::appendValue(const std::string &value)
 {
-    AbstractOptionStorage *option = _impl->_currentOption;
+    AbstractOptionStorage *option = impl_->currentOption_;
     GMX_RELEASE_ASSERT(option != NULL, "startOption() not called");
-    // Does not count correctly, but the actual count is not really used.
-    // TODO: Rename the variable to better reflect the usage.
-    ++_impl->_currentValueCount;
+    ++impl_->currentValueCount_;
     option->appendValue(value);
 }
 
 void OptionsAssigner::finishOption()
 {
-    AbstractOptionStorage *option = _impl->_currentOption;
+    AbstractOptionStorage *option = impl_->currentOption_;
     GMX_RELEASE_ASSERT(option != NULL, "startOption() not called");
-    bool bBoolReverseValue = false;
+    bool                   bBoolReverseValue = false;
     if (option->isBoolean())
     {
-        if (_impl->_currentValueCount == 0)
+        if (impl_->currentValueCount_ == 0)
         {
             // Should not throw, otherwise something is wrong.
             // TODO: Get rid of the hard-coded values.
-            option->appendValue(_impl->_reverseBoolean ? "0" : "1");
+            option->appendValue(impl_->reverseBoolean_ ? "0" : "1");
         }
-        else if (_impl->_reverseBoolean)
+        else if (impl_->reverseBoolean_)
         {
             bBoolReverseValue = true;
         }
     }
-    _impl->_currentOption = NULL;
-    _impl->_reverseBoolean = false;
+    impl_->currentOption_  = NULL;
+    impl_->reverseBoolean_ = false;
     option->finishSet();
     if (bBoolReverseValue)
     {
@@ -237,21 +290,21 @@ void OptionsAssigner::finishOption()
 void OptionsAssigner::finishSubSection()
 {
     // Should only be called if we are in a subsection.
-    GMX_RELEASE_ASSERT(_impl->inSubSection(), "startSubSection() not called");
-    _impl->_sectionStack.pop_back();
+    GMX_RELEASE_ASSERT(impl_->inSubSection(), "startSubSection() not called");
+    impl_->sectionStack_.pop_back();
 }
 
 void OptionsAssigner::finish()
 {
-    GMX_RELEASE_ASSERT(_impl->_currentOption == NULL, "finishOption() not called");
-    if (_impl->hasFlag(Impl::efNoStrictSectioning))
+    GMX_RELEASE_ASSERT(impl_->currentOption_ == NULL, "finishOption() not called");
+    if (impl_->bNoStrictSectioning_)
     {
-        while (_impl->inSubSection())
+        while (impl_->inSubSection())
         {
             finishSubSection();
         }
     }
-    GMX_RELEASE_ASSERT(!_impl->inSubSection(), "finishSubSection() not called");
+    GMX_RELEASE_ASSERT(!impl_->inSubSection(), "finishSubSection() not called");
 }
 
 } // namespace gmx