diff options
| author | Guest_account Guest_account prguest11 <prguest11@taipan.cs> | 2011-10-11 16:16:53 +0100 | 
|---|---|---|
| committer | Guest_account Guest_account prguest11 <prguest11@taipan.cs> | 2011-10-11 16:16:53 +0100 | 
| commit | 0af7d663194beddcde420349bbd91430e0b2e423 (patch) | |
| tree | f79558499f3756757b94267285ccd1418e55b8ea | |
| parent | 4671d578bd6d97105ac75b02e0144fe0df3abcb0 (diff) | |
remove implicit conversion-to-double operator from LogVal<T> that caused overflow errors, clean up some pf code
| -rw-r--r-- | decoder/aligner.cc | 2 | ||||
| -rwxr-xr-x | decoder/cfg.cc | 2 | ||||
| -rwxr-xr-x | decoder/cfg_format.h | 2 | ||||
| -rw-r--r-- | decoder/decoder.cc | 10 | ||||
| -rw-r--r-- | decoder/hg.cc | 4 | ||||
| -rw-r--r-- | decoder/rule_lexer.l | 2 | ||||
| -rw-r--r-- | decoder/trule.h | 15 | ||||
| -rw-r--r-- | gi/pf/brat.cc | 11 | ||||
| -rw-r--r-- | gi/pf/cbgi.cc | 10 | ||||
| -rw-r--r-- | gi/pf/dpnaive.cc | 12 | ||||
| -rw-r--r-- | gi/pf/itg.cc | 11 | ||||
| -rw-r--r-- | gi/pf/pfbrat.cc | 11 | ||||
| -rw-r--r-- | gi/pf/pfdist.cc | 11 | ||||
| -rw-r--r-- | gi/pf/pfnaive.cc | 11 | ||||
| -rw-r--r-- | mteval/mbr_kbest.cc | 4 | ||||
| -rw-r--r-- | phrasinator/ccrp_nt.h | 24 | ||||
| -rw-r--r-- | training/mpi_batch_optimize.cc | 2 | ||||
| -rw-r--r-- | training/mpi_compute_cllh.cc | 51 | ||||
| -rw-r--r-- | training/mpi_online_optimize.cc | 4 | ||||
| -rw-r--r-- | utils/logval.h | 10 | 
20 files changed, 78 insertions, 131 deletions
| diff --git a/decoder/aligner.cc b/decoder/aligner.cc index 292ee123..53e059fb 100644 --- a/decoder/aligner.cc +++ b/decoder/aligner.cc @@ -165,7 +165,7 @@ inline void WriteProbGrid(const Array2D<prob_t>& m, ostream* pos) {        if (m(i,j) == prob_t::Zero()) {          os << "\t---X---";        } else { -        snprintf(b, 1024, "%0.5f", static_cast<double>(m(i,j))); +        snprintf(b, 1024, "%0.5f", m(i,j).as_float());          os << '\t' << b;        }      } diff --git a/decoder/cfg.cc b/decoder/cfg.cc index 651978d2..cd7e66e9 100755 --- a/decoder/cfg.cc +++ b/decoder/cfg.cc @@ -639,7 +639,7 @@ void CFG::Print(std::ostream &o,CFGFormat const& f) const {      o << '['<<f.goal_nt_name <<']';      WordID rhs=-goal_nt;      f.print_rhs(o,*this,&rhs,&rhs+1); -    if (pushed_inside!=1) +    if (pushed_inside!=prob_t::One())        f.print_features(o,pushed_inside);      o<<'\n';    } diff --git a/decoder/cfg_format.h b/decoder/cfg_format.h index c6a594b8..2f40d483 100755 --- a/decoder/cfg_format.h +++ b/decoder/cfg_format.h @@ -101,7 +101,7 @@ struct CFGFormat {    }    void print_features(std::ostream &o,prob_t p,FeatureVector const& fv=FeatureVector()) const { -    bool logp=(logprob_feat && p!=1); +    bool logp=(logprob_feat && p!=prob_t::One());      if (features || logp) {        o << partsep;        if (logp) diff --git a/decoder/decoder.cc b/decoder/decoder.cc index c4fe3c4d..3b53fd6b 100644 --- a/decoder/decoder.cc +++ b/decoder/decoder.cc @@ -325,7 +325,7 @@ struct DecoderImpl {    static void ConvertSV(const SparseVector<prob_t>& src, SparseVector<double>* trg) {      for (SparseVector<prob_t>::const_iterator it = src.begin(); it != src.end(); ++it) -      trg->set_value(it->first, it->second); +      trg->set_value(it->first, it->second.as_float());    }  }; @@ -788,10 +788,10 @@ bool DecoderImpl::Decode(const string& input, DecoderObserver* o) {    const bool show_tree_structure=conf.count("show_tree_structure");    if (!SILENT) forest_stats(forest,"  Init. forest",show_tree_structure,oracle.show_derivation);    if (conf.count("show_expected_length")) { -    const PRPair<double, double> res = -      Inside<PRPair<double, double>, -             PRWeightFunction<double, EdgeProb, double, ELengthWeightFunction> >(forest); -    cerr << "  Expected length  (words): " << res.r / res.p << "\t" << res << endl; +    const PRPair<prob_t, prob_t> res = +      Inside<PRPair<prob_t, prob_t>, +             PRWeightFunction<prob_t, EdgeProb, prob_t, ELengthWeightFunction> >(forest); +    cerr << "  Expected length  (words): " << (res.r / res.p).as_float() << "\t" << res << endl;    }    if (conf.count("show_partition")) { diff --git a/decoder/hg.cc b/decoder/hg.cc index 3ad17f1a..180986d7 100644 --- a/decoder/hg.cc +++ b/decoder/hg.cc @@ -157,14 +157,14 @@ prob_t Hypergraph::ComputeEdgePosteriors(double scale, vector<prob_t>* posts) co    const ScaledEdgeProb weight(scale);    const ScaledTransitionEventWeightFunction w2(scale);    SparseVector<prob_t> pv; -  const double inside = InsideOutside<prob_t, +  const prob_t inside = InsideOutside<prob_t,                    ScaledEdgeProb,                    SparseVector<prob_t>,                    ScaledTransitionEventWeightFunction>(*this, &pv, weight, w2);    posts->resize(edges_.size());    for (int i = 0; i < edges_.size(); ++i)      (*posts)[i] = prob_t(pv.value(i)); -  return prob_t(inside); +  return inside;  }  prob_t Hypergraph::ComputeBestPathThroughEdges(vector<prob_t>* post) const { diff --git a/decoder/rule_lexer.l b/decoder/rule_lexer.l index 9331d8ed..083a5bb1 100644 --- a/decoder/rule_lexer.l +++ b/decoder/rule_lexer.l @@ -220,6 +220,8 @@ NT [^\t \[\],]+                    std::cerr << "Line " << lex_line << ": LHS and RHS arity mismatch!\n";                    abort();                  } +		// const bool ignore_grammar_features = false; +		// if (ignore_grammar_features) scfglex_num_feats = 0;  		TRulePtr rp(new TRule(scfglex_lhs, scfglex_src_rhs, scfglex_src_rhs_size, scfglex_trg_rhs, scfglex_trg_rhs_size, scfglex_feat_ids, scfglex_feat_vals, scfglex_num_feats, scfglex_src_arity, scfglex_als, scfglex_num_als));      check_and_update_ctf_stack(rp);      TRulePtr coarse_rp = ((ctf_level == 0) ? TRulePtr() : ctf_rule_stack.top()); diff --git a/decoder/trule.h b/decoder/trule.h index 4df4ec90..8eb2a059 100644 --- a/decoder/trule.h +++ b/decoder/trule.h @@ -5,7 +5,9 @@  #include <vector>  #include <cassert>  #include <iostream> -#include <boost/shared_ptr.hpp> + +#include "boost/shared_ptr.hpp" +#include "boost/functional/hash.hpp"  #include "sparse_vector.h"  #include "wordid.h" @@ -162,4 +164,15 @@ class TRule {    bool SanityCheck() const;  }; +inline size_t hash_value(const TRule& r) { +  size_t h = boost::hash_value(r.e_); +  boost::hash_combine(h, -r.lhs_); +  boost::hash_combine(h, boost::hash_value(r.f_)); +  return h; +} + +inline bool operator==(const TRule& a, const TRule& b) { +  return (a.lhs_ == b.lhs_ && a.e_ == b.e_ && a.f_ == b.f_); +} +  #endif diff --git a/gi/pf/brat.cc b/gi/pf/brat.cc index 4c6ba3ef..7b60ef23 100644 --- a/gi/pf/brat.cc +++ b/gi/pf/brat.cc @@ -25,17 +25,6 @@ static unsigned kMAX_SRC_PHRASE;  static unsigned kMAX_TRG_PHRASE;  struct FSTState; -size_t hash_value(const TRule& r) { -  size_t h = 2 - r.lhs_; -  boost::hash_combine(h, boost::hash_value(r.e_)); -  boost::hash_combine(h, boost::hash_value(r.f_)); -  return h; -} - -bool operator==(const TRule& a, const TRule& b) { -  return (a.lhs_ == b.lhs_ && a.e_ == b.e_ && a.f_ == b.f_); -} -  double log_poisson(unsigned x, const double& lambda) {    assert(lambda > 0.0);    return log(lambda) * x - lgamma(x + 1) - lambda; diff --git a/gi/pf/cbgi.cc b/gi/pf/cbgi.cc index 20204e8a..97f1ba34 100644 --- a/gi/pf/cbgi.cc +++ b/gi/pf/cbgi.cc @@ -27,16 +27,6 @@ double log_decay(unsigned x, const double& b) {    return log(b - 1) - x * log(b);  } -size_t hash_value(const TRule& r) { -  // TODO fix hash function -  size_t h = boost::hash_value(r.e_) * boost::hash_value(r.f_) * r.lhs_; -  return h; -} - -bool operator==(const TRule& a, const TRule& b) { -  return (a.lhs_ == b.lhs_ && a.e_ == b.e_ && a.f_ == b.f_); -} -  struct SimpleBase {    SimpleBase(unsigned esize, unsigned fsize, unsigned ntsize = 144) :      uniform_e(-log(esize)), diff --git a/gi/pf/dpnaive.cc b/gi/pf/dpnaive.cc index 582d1be7..608f73d5 100644 --- a/gi/pf/dpnaive.cc +++ b/gi/pf/dpnaive.cc @@ -20,18 +20,6 @@ namespace po = boost::program_options;  static unsigned kMAX_SRC_PHRASE;  static unsigned kMAX_TRG_PHRASE; -struct FSTState; - -size_t hash_value(const TRule& r) { -  size_t h = 2 - r.lhs_; -  boost::hash_combine(h, boost::hash_value(r.e_)); -  boost::hash_combine(h, boost::hash_value(r.f_)); -  return h; -} - -bool operator==(const TRule& a, const TRule& b) { -  return (a.lhs_ == b.lhs_ && a.e_ == b.e_ && a.f_ == b.f_); -}  void InitCommandLine(int argc, char** argv, po::variables_map* conf) {    po::options_description opts("Configuration options"); diff --git a/gi/pf/itg.cc b/gi/pf/itg.cc index 2c2a86f9..ac3c16a3 100644 --- a/gi/pf/itg.cc +++ b/gi/pf/itg.cc @@ -27,17 +27,6 @@ ostream& operator<<(ostream& os, const vector<WordID>& p) {    return os << ']';  } -size_t hash_value(const TRule& r) { -  size_t h = boost::hash_value(r.e_); -  boost::hash_combine(h, -r.lhs_); -  boost::hash_combine(h, boost::hash_value(r.f_)); -  return h; -} - -bool operator==(const TRule& a, const TRule& b) { -  return (a.lhs_ == b.lhs_ && a.e_ == b.e_ && a.f_ == b.f_); -} -  double log_poisson(unsigned x, const double& lambda) {    assert(lambda > 0.0);    return log(lambda) * x - lgamma(x + 1) - lambda; diff --git a/gi/pf/pfbrat.cc b/gi/pf/pfbrat.cc index 4c6ba3ef..7b60ef23 100644 --- a/gi/pf/pfbrat.cc +++ b/gi/pf/pfbrat.cc @@ -25,17 +25,6 @@ static unsigned kMAX_SRC_PHRASE;  static unsigned kMAX_TRG_PHRASE;  struct FSTState; -size_t hash_value(const TRule& r) { -  size_t h = 2 - r.lhs_; -  boost::hash_combine(h, boost::hash_value(r.e_)); -  boost::hash_combine(h, boost::hash_value(r.f_)); -  return h; -} - -bool operator==(const TRule& a, const TRule& b) { -  return (a.lhs_ == b.lhs_ && a.e_ == b.e_ && a.f_ == b.f_); -} -  double log_poisson(unsigned x, const double& lambda) {    assert(lambda > 0.0);    return log(lambda) * x - lgamma(x + 1) - lambda; diff --git a/gi/pf/pfdist.cc b/gi/pf/pfdist.cc index 18dfd03b..81abd61b 100644 --- a/gi/pf/pfdist.cc +++ b/gi/pf/pfdist.cc @@ -24,17 +24,6 @@ namespace po = boost::program_options;  shared_ptr<MT19937> prng; -size_t hash_value(const TRule& r) { -  size_t h = boost::hash_value(r.e_); -  boost::hash_combine(h, -r.lhs_); -  boost::hash_combine(h, boost::hash_value(r.f_)); -  return h; -} - -bool operator==(const TRule& a, const TRule& b) { -  return (a.lhs_ == b.lhs_ && a.e_ == b.e_ && a.f_ == b.f_); -} -  void InitCommandLine(int argc, char** argv, po::variables_map* conf) {    po::options_description opts("Configuration options");    opts.add_options() diff --git a/gi/pf/pfnaive.cc b/gi/pf/pfnaive.cc index 43c604c3..c30e7c4f 100644 --- a/gi/pf/pfnaive.cc +++ b/gi/pf/pfnaive.cc @@ -24,17 +24,6 @@ namespace po = boost::program_options;  shared_ptr<MT19937> prng; -size_t hash_value(const TRule& r) { -  size_t h = boost::hash_value(r.e_); -  boost::hash_combine(h, -r.lhs_); -  boost::hash_combine(h, boost::hash_value(r.f_)); -  return h; -} - -bool operator==(const TRule& a, const TRule& b) { -  return (a.lhs_ == b.lhs_ && a.e_ == b.e_ && a.f_ == b.f_); -} -  void InitCommandLine(int argc, char** argv, po::variables_map* conf) {    po::options_description opts("Configuration options");    opts.add_options() diff --git a/mteval/mbr_kbest.cc b/mteval/mbr_kbest.cc index 2867b36b..64a6a8bf 100644 --- a/mteval/mbr_kbest.cc +++ b/mteval/mbr_kbest.cc @@ -32,7 +32,7 @@ void InitCommandLine(int argc, char** argv, po::variables_map* conf) {  }  struct LossComparer { -  bool operator()(const pair<vector<WordID>, double>& a, const pair<vector<WordID>, double>& b) const { +  bool operator()(const pair<vector<WordID>, prob_t>& a, const pair<vector<WordID>, prob_t>& b) const {      return a.second < b.second;    }  }; @@ -108,7 +108,7 @@ int main(int argc, char** argv) {            ScoreP s = scorer->ScoreCandidate(list[j].first);            double loss = 1.0 - s->ComputeScore();            if (type == TER || type == AER) loss = 1.0 - loss; -          double weighted_loss = loss * (joints[j] / marginal); +          double weighted_loss = loss * (joints[j] / marginal).as_float();            wl_acc += weighted_loss;            if ((!output_list) && wl_acc > mbr_loss) break;          } diff --git a/phrasinator/ccrp_nt.h b/phrasinator/ccrp_nt.h index 163b643a..811bce73 100644 --- a/phrasinator/ccrp_nt.h +++ b/phrasinator/ccrp_nt.h @@ -50,15 +50,26 @@ class CCRP_NoTable {      return it->second;    } -  void increment(const Dish& dish) { -    ++custs_[dish]; +  int increment(const Dish& dish) { +    int table_diff = 0; +    if (++custs_[dish] == 1) +      table_diff = 1;      ++num_customers_; +    return table_diff;    } -  void decrement(const Dish& dish) { -    if ((--custs_[dish]) == 0) +  int decrement(const Dish& dish) { +    int table_diff = 0; +    int nc = --custs_[dish]; +    if (nc == 0) {        custs_.erase(dish); +      table_diff = -1; +    } else if (nc < 0) { +      std::cerr << "Dish counts dropped below zero for: " << dish << std::endl; +      abort(); +    }      --num_customers_; +    return table_diff;    }    double prob(const Dish& dish, const double& p0) const { @@ -66,6 +77,11 @@ class CCRP_NoTable {      return (at_table + p0 * concentration_) / (num_customers_ + concentration_);    } +  double logprob(const Dish& dish, const double& logp0) const { +    const unsigned at_table = num_customers(dish); +    return log(at_table + exp(logp0 + log(concentration_))) - log(num_customers_ + concentration_); +  } +    double log_crp_prob() const {      return log_crp_prob(concentration_);    } diff --git a/training/mpi_batch_optimize.cc b/training/mpi_batch_optimize.cc index 0ba8c530..046e921c 100644 --- a/training/mpi_batch_optimize.cc +++ b/training/mpi_batch_optimize.cc @@ -92,7 +92,7 @@ struct TrainingObserver : public DecoderObserver {    void SetLocalGradientAndObjective(vector<double>* g, double* o) const {      *o = acc_obj;      for (SparseVector<prob_t>::const_iterator it = acc_grad.begin(); it != acc_grad.end(); ++it) -      (*g)[it->first] = it->second; +      (*g)[it->first] = it->second.as_float();    }    virtual void NotifyDecodingStart(const SentenceMetadata& smeta) { diff --git a/training/mpi_compute_cllh.cc b/training/mpi_compute_cllh.cc index b496d196..d5caa745 100644 --- a/training/mpi_compute_cllh.cc +++ b/training/mpi_compute_cllh.cc @@ -1,6 +1,4 @@ -#include <sstream>  #include <iostream> -#include <fstream>  #include <vector>  #include <cassert>  #include <cmath> @@ -12,6 +10,7 @@  #include <boost/program_options.hpp>  #include <boost/program_options/variables_map.hpp> +#include "sentence_metadata.h"  #include "verbose.h"  #include "hg.h"  #include "prob.h" @@ -52,7 +51,8 @@ bool InitCommandLine(int argc, char** argv, po::variables_map* conf) {    return true;  } -void ReadTrainingCorpus(const string& fname, int rank, int size, vector<string>* c, vector<int>* ids) { +void ReadInstances(const string& fname, int rank, int size, vector<string>* c) { +  assert(fname != "-");    ReadFile rf(fname);    istream& in = *rf.stream();    string line; @@ -60,20 +60,16 @@ void ReadTrainingCorpus(const string& fname, int rank, int size, vector<string>*    while(in) {      getline(in, line);      if (!in) break; -    if (lc % size == rank) { -      c->push_back(line); -      ids->push_back(lc); -    } +    if (lc % size == rank) c->push_back(line);      ++lc;    }  }  static const double kMINUS_EPSILON = -1e-6; -struct TrainingObserver : public DecoderObserver { -  void Reset() { -    acc_obj = 0; -  }  +struct ConditionalLikelihoodObserver : public DecoderObserver { + +  ConditionalLikelihoodObserver() : trg_words(), acc_obj(), cur_obj() {}    virtual void NotifyDecodingStart(const SentenceMetadata&) {      cur_obj = 0; @@ -120,8 +116,10 @@ struct TrainingObserver : public DecoderObserver {      }      assert(!isnan(log_ref_z));      acc_obj += (cur_obj - log_ref_z); +    trg_words += smeta.GetReference().size();    } +  unsigned trg_words;    double acc_obj;    double cur_obj;    int state; @@ -161,35 +159,32 @@ int main(int argc, char** argv) {    if (conf.count("weights"))      Weights::InitFromFile(conf["weights"].as<string>(), &weights); -  // freeze feature set -  //const bool freeze_feature_set = conf.count("freeze_feature_set"); -  //if (freeze_feature_set) FD::Freeze(); - -  vector<string> corpus; vector<int> ids; -  ReadTrainingCorpus(conf["training_data"].as<string>(), rank, size, &corpus, &ids); +  vector<string> corpus; +  ReadInstances(conf["training_data"].as<string>(), rank, size, &corpus);    assert(corpus.size() > 0); -  assert(corpus.size() == ids.size()); - -  TrainingObserver observer; -  double objective = 0; -  observer.Reset();    if (rank == 0) -    cerr << "Each processor is decoding " << corpus.size() << " training examples...\n"; +    cerr << "Each processor is decoding ~" << corpus.size() << " training examples...\n"; -  for (int i = 0; i < corpus.size(); ++i) { -    decoder.SetId(ids[i]); +  ConditionalLikelihoodObserver observer; +  for (int i = 0; i < corpus.size(); ++i)      decoder.Decode(corpus[i], &observer); -  } +  double objective = 0; +  unsigned total_words = 0;  #ifdef HAVE_MPI    reduce(world, observer.acc_obj, objective, std::plus<double>(), 0); +  reduce(world, observer.trg_words, total_words, std::plus<unsigned>(), 0);  #else    objective = observer.acc_obj;  #endif -  if (rank == 0) -    cout << "OBJECTIVE: " << objective << endl; +  if (rank == 0) { +    cout << "CONDITIONAL LOG_e LIKELIHOOD: " << objective << endl; +    cout << "CONDITIONAL LOG_2 LIKELIHOOD: " << (objective/log(2)) << endl; +    cout << "         CONDITIONAL ENTROPY: " << (objective/log(2) / total_words) << endl; +    cout << "                  PERPLEXITY: " << pow(2, (objective/log(2) / total_words)) << endl; +  }    return 0;  } diff --git a/training/mpi_online_optimize.cc b/training/mpi_online_optimize.cc index 2ef4a2e7..f87b7274 100644 --- a/training/mpi_online_optimize.cc +++ b/training/mpi_online_optimize.cc @@ -94,7 +94,7 @@ struct TrainingObserver : public DecoderObserver {    void SetLocalGradientAndObjective(vector<double>* g, double* o) const {      *o = acc_obj;      for (SparseVector<prob_t>::const_iterator it = acc_grad.begin(); it != acc_grad.end(); ++it) -      (*g)[it->first] = it->second; +      (*g)[it->first] = it->second.as_float();    }    virtual void NotifyDecodingStart(const SentenceMetadata& smeta) { @@ -158,7 +158,7 @@ struct TrainingObserver : public DecoderObserver {    void GetGradient(SparseVector<double>* g) const {      g->clear();      for (SparseVector<prob_t>::const_iterator it = acc_grad.begin(); it != acc_grad.end(); ++it) -      g->set_value(it->first, it->second); +      g->set_value(it->first, it->second.as_float());    }    int total_complete; diff --git a/utils/logval.h b/utils/logval.h index 6fdc2c42..8a59d0b1 100644 --- a/utils/logval.h +++ b/utils/logval.h @@ -25,12 +25,13 @@ class LogVal {    typedef LogVal<T> Self;    LogVal() : s_(), v_(LOGVAL_LOG0) {} -  explicit LogVal(double x) : s_(std::signbit(x)), v_(s_ ? std::log(-x) : std::log(x)) {} +  LogVal(double x) : s_(std::signbit(x)), v_(s_ ? std::log(-x) : std::log(x)) {} +  const Self& operator=(double x) { s_ = std::signbit(x); v_ = s_ ? std::log(-x) : std::log(x); return *this; }    LogVal(init_minus_1) : s_(true),v_(0) {  }    LogVal(init_1) : s_(),v_(0) {  }    LogVal(init_0) : s_(),v_(LOGVAL_LOG0) {  } -  LogVal(int x) : s_(x<0), v_(s_ ? std::log(-x) : std::log(x)) {} -  LogVal(unsigned x) : s_(0), v_(std::log(x)) { } +  explicit LogVal(int x) : s_(x<0), v_(s_ ? std::log(-x) : std::log(x)) {} +  explicit LogVal(unsigned x) : s_(0), v_(std::log(x)) { }    LogVal(double lnx,bool sign) : s_(sign),v_(lnx) {}    LogVal(double lnx,init_lnx) : s_(),v_(lnx) {}    static Self exp(T lnx) { return Self(lnx,false); } @@ -141,9 +142,6 @@ class LogVal {      return pow(1/root);    } -  operator T() const { -    if (s_) return -std::exp(v_); else return std::exp(v_); -  }    T as_float() const {      if (s_) return -std::exp(v_); else return std::exp(v_);    } | 
