Do not use MachineOperand::isVirtualRegister either!
[oota-llvm.git] / lib / CodeGen / LiveIntervalAnalysis.cpp
index fe47a3661d8e2838d8c1fdf4993684defb47b83a..caa9e2e391df6ca352590aff3ea65730b5df3536 100644 (file)
 
 #define DEBUG_TYPE "liveintervals"
 #include "llvm/CodeGen/LiveIntervals.h"
-#include "llvm/Function.h"
 #include "llvm/Analysis/LoopInfo.h"
 #include "llvm/CodeGen/LiveVariables.h"
 #include "llvm/CodeGen/MachineFrameInfo.h"
-#include "llvm/CodeGen/MachineFunctionPass.h"
 #include "llvm/CodeGen/MachineInstr.h"
 #include "llvm/CodeGen/Passes.h"
 #include "llvm/CodeGen/SSARegMap.h"
 #include "llvm/Target/MRegisterInfo.h"
 #include "llvm/Target/TargetInstrInfo.h"
 #include "llvm/Target/TargetMachine.h"
-#include "llvm/Target/TargetRegInfo.h"
 #include "llvm/Support/CFG.h"
+#include "Support/CommandLine.h"
 #include "Support/Debug.h"
-#include "Support/DepthFirstIterator.h"
 #include "Support/Statistic.h"
 #include <cmath>
 #include <iostream>
@@ -44,6 +41,12 @@ namespace {
                                       "Live Interval Analysis");
 
     Statistic<> numIntervals("liveintervals", "Number of intervals");
+    Statistic<> numJoined   ("liveintervals", "Number of joined intervals");
+
+    cl::opt<bool>
+    join("join-liveintervals",
+         cl::desc("Join compatible live intervals"),
+         cl::init(true));
 };
 
 void LiveIntervals::getAnalysisUsage(AnalysisUsage &AU) const
@@ -57,6 +60,17 @@ void LiveIntervals::getAnalysisUsage(AnalysisUsage &AU) const
     MachineFunctionPass::getAnalysisUsage(AU);
 }
 
+void LiveIntervals::releaseMemory()
+{
+    mbbi2mbbMap_.clear();
+    mi2iMap_.clear();
+    r2iMap_.clear();
+    r2iMap_.clear();
+    r2rMap_.clear();
+    intervals_.clear();
+}
+
+
 /// runOnMachineFunction - Register allocate the whole function
 ///
 bool LiveIntervals::runOnMachineFunction(MachineFunction &fn) {
@@ -65,33 +79,13 @@ bool LiveIntervals::runOnMachineFunction(MachineFunction &fn) {
     tm_ = &fn.getTarget();
     mri_ = tm_->getRegisterInfo();
     lv_ = &getAnalysis<LiveVariables>();
-    allocatableRegisters_.clear();
-    mbbi2mbbMap_.clear();
-    mi2iMap_.clear();
-    r2iMap_.clear();
-    r2iMap_.clear();
-    intervals_.clear();
-
-    // mark allocatable registers
-    allocatableRegisters_.resize(MRegisterInfo::FirstVirtualRegister);
-    // Loop over all of the register classes...
-    for (MRegisterInfo::regclass_iterator
-             rci = mri_->regclass_begin(), rce = mri_->regclass_end();
-         rci != rce; ++rci) {
-        // Loop over all of the allocatable registers in the function...
-        for (TargetRegisterClass::iterator
-                 i = (*rci)->allocation_order_begin(*mf_),
-                 e = (*rci)->allocation_order_end(*mf_); i != e; ++i) {
-            allocatableRegisters_[*i] = true;  // The reg is allocatable!
-        }
-    }
 
     // number MachineInstrs
     unsigned miIndex = 0;
     for (MachineFunction::iterator mbb = mf_->begin(), mbbEnd = mf_->end();
          mbb != mbbEnd; ++mbb) {
         const std::pair<MachineBasicBlock*, unsigned>& entry =
-            lv_->getMachineBasicBlockInfo(&*mbb);
+            lv_->getMachineBasicBlockInfo(mbb);
         bool inserted = mbbi2mbbMap_.insert(std::make_pair(entry.second,
                                                            entry.first)).second;
         assert(inserted && "multiple index -> MachineBasicBlock");
@@ -100,7 +94,7 @@ bool LiveIntervals::runOnMachineFunction(MachineFunction &fn) {
              mi != miEnd; ++mi) {
             inserted = mi2iMap_.insert(std::make_pair(*mi, miIndex)).second;
             assert(inserted && "multiple MachineInstr -> index mappings");
-            ++miIndex;
+            miIndex += 2;
         }
     }
 
@@ -110,36 +104,42 @@ bool LiveIntervals::runOnMachineFunction(MachineFunction &fn) {
     const LoopInfo& loopInfo = getAnalysis<LoopInfo>();
     const TargetInstrInfo& tii = tm_->getInstrInfo();
 
-    for (MbbIndex2MbbMap::iterator
-             it = mbbi2mbbMap_.begin(), itEnd = mbbi2mbbMap_.end();
-         it != itEnd; ++it) {
-        MachineBasicBlock* mbb = it->second;
-
+    for (MachineFunction::const_iterator mbbi = mf_->begin(),
+             mbbe = mf_->end(); mbbi != mbbe; ++mbbi) {
+        const MachineBasicBlock* mbb = mbbi;
         unsigned loopDepth = loopInfo.getLoopDepth(mbb->getBasicBlock());
 
-        for (MachineBasicBlock::iterator mi = mbb->begin(), miEnd = mbb->end();
-             mi != miEnd; ++mi) {
-            MachineInstr* instr = *mi;
-            for (int i = instr->getNumOperands() - 1; i >= 0; --i) {
-                MachineOperand& mop = instr->getOperand(i);
-
-                if (!mop.isVirtualRegister())
-                    continue;
-
-                unsigned reg = mop.getAllocatedRegNum();
-                Reg2IntervalMap::iterator r2iit = r2iMap_.find(reg);
-                assert(r2iit != r2iMap_.end());
-                intervals_[r2iit->second].weight += pow(10.0F, loopDepth);
+        for (MachineBasicBlock::const_iterator mii = mbb->begin(),
+                 mie = mbb->end(); mii != mie; ++mii) {
+            MachineInstr* mi = *mii;
+
+            for (int i = mi->getNumOperands() - 1; i >= 0; --i) {
+                MachineOperand& mop = mi->getOperand(i);
+                if (mop.isRegister() &&
+                    MRegisterInfo::isVirtualRegister(mop.getReg())) {
+                    unsigned reg = mop.getAllocatedRegNum();
+                    Reg2IntervalMap::iterator r2iit = r2iMap_.find(reg);
+                    assert(r2iit != r2iMap_.end());
+                    r2iit->second->weight += pow(10.0F, loopDepth);
+                }
             }
         }
     }
 
+    // join intervals if requested
+    if (join) joinIntervals();
+
+    numIntervals += intervals_.size();
+
+    intervals_.sort(StartPointComp());
+    DEBUG(std::copy(intervals_.begin(), intervals_.end(),
+                    std::ostream_iterator<Interval>(std::cerr, "\n")));
     return true;
 }
 
 void LiveIntervals::printRegName(unsigned reg) const
 {
-    if (reg < MRegisterInfo::FirstVirtualRegister)
+    if (MRegisterInfo::isPhysicalRegister(reg))
         std::cerr << mri_->getName(reg);
     else
         std::cerr << '%' << reg;
@@ -149,38 +149,39 @@ void LiveIntervals::handleVirtualRegisterDef(MachineBasicBlock* mbb,
                                              MachineBasicBlock::iterator mi,
                                              unsigned reg)
 {
-    DEBUG(std::cerr << "\t\t\tregister: ";printRegName(reg); std::cerr << '\n');
-
-    unsigned instrIndex = getInstructionIndex(*mi);
+    DEBUG(std::cerr << "\t\tregister: ";printRegName(reg); std::cerr << '\n');
 
     LiveVariables::VarInfo& vi = lv_->getVarInfo(reg);
 
     Interval* interval = 0;
-    Reg2IntervalMap::iterator r2iit = r2iMap_.find(reg);
-    if (r2iit == r2iMap_.end()) {
+    Reg2IntervalMap::iterator r2iit = r2iMap_.lower_bound(reg);
+    if (r2iit == r2iMap_.end() || r2iit->first != reg) {
         // add new interval
         intervals_.push_back(Interval(reg));
         // update interval index for this register
-        r2iMap_[reg] = intervals_.size() - 1;
+        r2iMap_.insert(r2iit, std::make_pair(reg, --intervals_.end()));
         interval = &intervals_.back();
+
+        // iterate over all of the blocks that the variable is
+        // completely live in, adding them to the live
+        // interval. obviously we only need to do this once.
+        for (unsigned i = 0, e = vi.AliveBlocks.size(); i != e; ++i) {
+            if (vi.AliveBlocks[i]) {
+                MachineBasicBlock* mbb = lv_->getIndexMachineBasicBlock(i);
+                if (!mbb->empty()) {
+                    interval->addRange(getInstructionIndex(mbb->front()),
+                                       getInstructionIndex(mbb->back()) + 1);
+                }
+            }
+        }
     }
     else {
-        interval = &intervals_[r2iit->second];
+        interval = &*r2iit->second;
     }
 
-    for (MbbIndex2MbbMap::iterator
-             it = mbbi2mbbMap_.begin(), itEnd = mbbi2mbbMap_.end();
-         it != itEnd; ++it) {
-        unsigned liveBlockIndex = it->first;
-        MachineBasicBlock* liveBlock = it->second;
-        if (liveBlockIndex < vi.AliveBlocks.size() &&
-            vi.AliveBlocks[liveBlockIndex] &&
-            !liveBlock->empty()) {
-            unsigned start =  getInstructionIndex(liveBlock->front());
-            unsigned end = getInstructionIndex(liveBlock->back()) + 1;
-            interval->addRange(start, end);
-        }
-    }
+    // we consider defs to happen at the second time slot of the
+    // instruction
+    unsigned instrIndex = getInstructionIndex(*mi) + 1;
 
     bool killedInDefiningBasicBlock = false;
     for (int i = 0, e = vi.Kills.size(); i != e; ++i) {
@@ -189,7 +190,13 @@ void LiveIntervals::handleVirtualRegisterDef(MachineBasicBlock* mbb,
         unsigned start = (mbb == killerBlock ?
                           instrIndex :
                           getInstructionIndex(killerBlock->front()));
-        unsigned end = getInstructionIndex(killerInstr) + 1;
+        unsigned end = (killerInstr == *mi ?
+                        instrIndex + 1 : // dead
+                        getInstructionIndex(killerInstr) + 1); // killed
+        // we do not want to add invalid ranges. these can happen when
+        // a variable has its latest use and is redefined later on in
+        // the same basic block (common with variables introduced by
+        // PHI elimination)
         if (start < end) {
             killedInDefiningBasicBlock |= mbb == killerBlock;
             interval->addRange(start, end);
@@ -206,51 +213,51 @@ void LiveIntervals::handlePhysicalRegisterDef(MachineBasicBlock* mbb,
                                               MachineBasicBlock::iterator mi,
                                               unsigned reg)
 {
-    DEBUG(std::cerr << "\t\t\tregister: ";printRegName(reg); std::cerr << '\n');
-    if (!lv_->getAllocatablePhysicalRegisters()[reg]) {
-        DEBUG(std::cerr << "\t\t\t\tnon allocatable register: ignoring\n");
-        return;
+    typedef LiveVariables::killed_iterator KillIter;
+
+    DEBUG(std::cerr << "\t\tregister: "; printRegName(reg));
+
+    MachineBasicBlock::iterator e = mbb->end();
+    // we consider defs to happen at the second time slot of the
+    // instruction
+    unsigned start, end;
+    start = end = getInstructionIndex(*mi) + 1;
+
+    // a variable can be dead by the instruction defining it
+    for (KillIter ki = lv_->dead_begin(*mi), ke = lv_->dead_end(*mi);
+         ki != ke; ++ki) {
+        if (reg == ki->second) {
+            DEBUG(std::cerr << " dead\n");
+            ++end;
+            goto exit;
+        }
     }
 
-    unsigned start = getInstructionIndex(*mi);
-    unsigned end = start;
-
-    for (MachineBasicBlock::iterator e = mbb->end(); mi != e; ++mi) {
-        for (LiveVariables::killed_iterator
-                 ki = lv_->dead_begin(*mi),
-                 ke = lv_->dead_end(*mi);
+    // a variable can only be killed by subsequent instructions
+    do {
+        ++mi;
+        end += 2;
+        for (KillIter ki = lv_->killed_begin(*mi), ke = lv_->killed_end(*mi);
              ki != ke; ++ki) {
             if (reg == ki->second) {
-                end = getInstructionIndex(ki->first) + 1;
+                DEBUG(std::cerr << " killed\n");
                 goto exit;
             }
         }
+    } while (mi != e);
 
-        for (LiveVariables::killed_iterator
-                 ki = lv_->killed_begin(*mi),
-                 ke = lv_->killed_end(*mi);
-             ki != ke; ++ki) {
-            if (reg == ki->second) {
-                end = getInstructionIndex(ki->first) + 1;
-                goto exit;
-            }
-        }
-    }
 exit:
     assert(start < end && "did not find end of interval?");
 
-    Reg2IntervalMap::iterator r2iit = r2iMap_.find(reg);
-    if (r2iit != r2iMap_.end()) {
-        unsigned ii = r2iit->second;
-        Interval& interval = intervals_[ii];
-        interval.addRange(start, end);
+    Reg2IntervalMap::iterator r2iit = r2iMap_.lower_bound(reg);
+    if (r2iit != r2iMap_.end() && r2iit->first == reg) {
+        r2iit->second->addRange(start, end);
     }
     else {
         intervals_.push_back(Interval(reg));
-        Interval& interval = intervals_.back();
         // update interval index for this register
-        r2iMap_[reg] = intervals_.size() - 1;
-        interval.addRange(start, end);
+        r2iMap_.insert(r2iit, std::make_pair(reg, --intervals_.end()));
+        intervals_.back().addRange(start, end);
     }
 }
 
@@ -258,9 +265,11 @@ void LiveIntervals::handleRegisterDef(MachineBasicBlock* mbb,
                                       MachineBasicBlock::iterator mi,
                                       unsigned reg)
 {
-    if (reg < MRegisterInfo::FirstVirtualRegister) {
-        if (allocatableRegisters_[reg]) {
+    if (MRegisterInfo::isPhysicalRegister(reg)) {
+        if (lv_->getAllocatablePhysicalRegisters()[reg]) {
             handlePhysicalRegisterDef(mbb, mi, reg);
+            for (const unsigned* as = mri_->getAliasSet(reg); *as; ++as)
+                handlePhysicalRegisterDef(mbb, mi, *as);
         }
     }
     else {
@@ -277,7 +286,7 @@ unsigned LiveIntervals::getInstructionIndex(MachineInstr* instr) const
 
 /// computeIntervals - computes the live intervals for virtual
 /// registers. for some ordering of the machine instructions [1,N] a
-/// live interval is an interval [i, j] where 1 <= i <= j <= N for
+/// live interval is an interval [i, j) where 1 <= i <= j < N for
 /// which a variable is live
 void LiveIntervals::computeIntervals()
 {
@@ -295,123 +304,280 @@ void LiveIntervals::computeIntervals()
             MachineInstr* instr = *mi;
             const TargetInstrDescriptor& tid =
                 tm_->getInstrInfo().get(instr->getOpcode());
-            DEBUG(std::cerr << "\t\tinstruction["
-                  << getInstructionIndex(instr) << "]: ";
+            DEBUG(std::cerr << "\t[" << getInstructionIndex(instr) << "] ";
                   instr->print(std::cerr, *tm_););
 
             // handle implicit defs
-            for (const unsigned* id = tid.ImplicitDefs; *id; ++id) {
-                unsigned physReg = *id;
-                handlePhysicalRegisterDef(mbb, mi, physReg);
-            }
+            for (const unsigned* id = tid.ImplicitDefs; *id; ++id)
+                handleRegisterDef(mbb, mi, *id);
 
             // handle explicit defs
             for (int i = instr->getNumOperands() - 1; i >= 0; --i) {
                 MachineOperand& mop = instr->getOperand(i);
+                // handle register defs - build intervals
+                if (mop.isRegister() && mop.isDef())
+                    handleRegisterDef(mbb, mi, mop.getAllocatedRegNum());
+            }
+        }
+    }
+}
+
+unsigned LiveIntervals::rep(unsigned reg)
+{
+    Reg2RegMap::iterator it = r2rMap_.find(reg);
+    if (it != r2rMap_.end())
+        return it->second = rep(it->second);
+    return reg;
+}
 
-                if (!mop.isRegister())
+void LiveIntervals::joinIntervals()
+{
+    DEBUG(std::cerr << "joining compatible intervals:\n");
+
+    const TargetInstrInfo& tii = tm_->getInstrInfo();
+
+    for (MachineFunction::const_iterator mbbi = mf_->begin(),
+             mbbe = mf_->end(); mbbi != mbbe; ++mbbi) {
+        const MachineBasicBlock* mbb = mbbi;
+        DEBUG(std::cerr << "machine basic block: "
+              << mbb->getBasicBlock()->getName() << "\n");
+
+        for (MachineBasicBlock::const_iterator mii = mbb->begin(),
+                 mie = mbb->end(); mii != mie; ++mii) {
+            MachineInstr* mi = *mii;
+            const TargetInstrDescriptor& tid =
+                tm_->getInstrInfo().get(mi->getOpcode());
+            DEBUG(std::cerr << "\t\tinstruction["
+                  << getInstructionIndex(mi) << "]: ";
+                  mi->print(std::cerr, *tm_););
+
+            // we only join virtual registers with allocatable
+            // physical registers since we do not have liveness information
+            // on not allocatable physical registers
+            unsigned regA, regB;
+            if (tii.isMoveInstr(*mi, regA, regB) &&
+                (MRegisterInfo::isVirtualRegister(regA) ||
+                 lv_->getAllocatablePhysicalRegisters()[regA]) &&
+                (MRegisterInfo::isVirtualRegister(regB) ||
+                 lv_->getAllocatablePhysicalRegisters()[regB])) {
+
+                // get representative registers
+                regA = rep(regA);
+                regB = rep(regB);
+
+                // if they are already joined we continue
+                if (regA == regB)
                     continue;
 
-                unsigned reg = mop.getAllocatedRegNum();
-                // handle defs - build intervals
-                if (mop.isDef()) {
-                    if (reg < MRegisterInfo::FirstVirtualRegister)
-                        handlePhysicalRegisterDef(mbb, mi, reg);
-                    else
-                        handleVirtualRegisterDef(mbb, mi, reg);
+                Reg2IntervalMap::iterator r2iA = r2iMap_.find(regA);
+                assert(r2iA != r2iMap_.end());
+                Reg2IntervalMap::iterator r2iB = r2iMap_.find(regB);
+                assert(r2iB != r2iMap_.end());
+
+                Intervals::iterator intA = r2iA->second;
+                Intervals::iterator intB = r2iB->second;
+
+                // both A and B are virtual registers
+                if (MRegisterInfo::isVirtualRegister(intA->reg) &&
+                    MRegisterInfo::isVirtualRegister(intB->reg)) {
+
+                    const TargetRegisterClass *rcA, *rcB;
+                    rcA = mf_->getSSARegMap()->getRegClass(intA->reg);
+                    rcB = mf_->getSSARegMap()->getRegClass(intB->reg);
+                    assert(rcA == rcB && "registers must be of the same class");
+
+                    // if their intervals do not overlap we join them
+                    if (!intB->overlaps(*intA)) {
+                        intA->join(*intB);
+                        r2iB->second = r2iA->second;
+                        r2rMap_.insert(std::make_pair(intB->reg, intA->reg));
+                        intervals_.erase(intB);
+                        ++numJoined;
+                    }
+                }
+                else if (MRegisterInfo::isPhysicalRegister(intA->reg) ^
+                         MRegisterInfo::isPhysicalRegister(intB->reg)) {
+                    if (MRegisterInfo::isPhysicalRegister(intB->reg)) {
+                        std::swap(regA, regB);
+                        std::swap(intA, intB);
+                        std::swap(r2iA, r2iB);
+                    }
+
+                    assert(MRegisterInfo::isPhysicalRegister(intA->reg) &&
+                           MRegisterInfo::isVirtualRegister(intB->reg) &&
+                           "A must be physical and B must be virtual");
+
+                    if (!intA->overlaps(*intB) &&
+                         !overlapsAliases(*intA, *intB)) {
+                        intA->join(*intB);
+                        r2iB->second = r2iA->second;
+                        r2rMap_.insert(std::make_pair(intB->reg, intA->reg));
+                        intervals_.erase(intB);
+                        ++numJoined;
+                    }
                 }
             }
         }
     }
+}
 
-    std::sort(intervals_.begin(), intervals_.end(), StartPointComp());
-    DEBUG(std::copy(intervals_.begin(), intervals_.end(),
-                    std::ostream_iterator<Interval>(std::cerr, "\n")));
+bool LiveIntervals::overlapsAliases(const Interval& lhs,
+                                    const Interval& rhs) const
+{
+    assert(MRegisterInfo::isPhysicalRegister(lhs.reg) &&
+           "first interval must describe a physical register");
+
+    for (const unsigned* as = mri_->getAliasSet(lhs.reg); *as; ++as) {
+        Reg2IntervalMap::const_iterator r2i = r2iMap_.find(*as);
+        assert(r2i != r2iMap_.end() && "alias does not have interval?");
+        if (rhs.overlaps(*r2i->second))
+            return true;
+    }
+
+    return false;
 }
 
 LiveIntervals::Interval::Interval(unsigned r)
-    : reg(r), hint(0),
-      weight((r < MRegisterInfo::FirstVirtualRegister ?
+    : reg(r),
+      weight((MRegisterInfo::isPhysicalRegister(r) ?
               std::numeric_limits<float>::max() : 0.0F))
 {
 
 }
 
+// An example for liveAt():
+//
+// this = [1,2), liveAt(0) will return false. The instruction defining
+// this spans slots [0,1]. Since it is a definition we say that it is
+// live in the second slot onwards. By ending the lifetime of this
+// interval at 2 it means that it is not used at all. liveAt(1)
+// returns true which means that this clobbers a register at
+// instruction at 0.
+//
+// this = [1,4), liveAt(0) will return false and liveAt(2) will return
+// true.  The variable is defined at instruction 0 and last used at 2.
+bool LiveIntervals::Interval::liveAt(unsigned index) const
+{
+    Range dummy(index, index+1);
+    Ranges::const_iterator r = std::upper_bound(ranges.begin(),
+                                                ranges.end(),
+                                                dummy);
+    if (r == ranges.begin())
+        return false;
+
+    --r;
+    return index >= r->first && index < r->second;
+}
+
+// An example for overlaps():
+//
+// 0: A = ...
+// 2: B = ...
+// 4: C = A + B ;; last use of A
+//
+// The live intervals should look like:
+//
+// A = [1, 5)
+// B = [3, x)
+// C = [5, y)
+//
+// A->overlaps(C) should return false since we want to be able to join
+// A and C.
+bool LiveIntervals::Interval::overlaps(const Interval& other) const
+{
+    Ranges::const_iterator i = ranges.begin();
+    Ranges::const_iterator ie = ranges.end();
+    Ranges::const_iterator j = other.ranges.begin();
+    Ranges::const_iterator je = other.ranges.end();
+    if (i->first < j->first) {
+        i = std::upper_bound(i, ie, *j);
+        if (i != ranges.begin()) --i;
+    }
+    else if (j->first < i->first) {
+        j = std::upper_bound(j, je, *i);
+        if (j != other.ranges.begin()) --j;
+    }
+
+    while (i != ie && j != je) {
+        if (i->first == j->first) {
+            return true;
+        }
+        else {
+            if (i->first > j->first) {
+                swap(i, j);
+                swap(ie, je);
+            }
+            assert(i->first < j->first);
+
+            if (i->second > j->first) {
+                return true;
+            }
+            else {
+                ++i;
+            }
+        }
+    }
+
+    return false;
+}
+
 void LiveIntervals::Interval::addRange(unsigned start, unsigned end)
 {
-    DEBUG(std::cerr << "\t\t\t\tadding range: [" << start <<','<< end << "]\n");
+    assert(start < end && "Invalid range to add!");
+    DEBUG(std::cerr << "\t\t\tadding range: [" << start <<','<< end << ") -> ");
     //assert(start < end && "invalid range?");
     Range range = std::make_pair(start, end);
     Ranges::iterator it =
         ranges.insert(std::upper_bound(ranges.begin(), ranges.end(), range),
                       range);
 
-    DEBUG(std::cerr << "\t\t\t\tbefore merge forward: " << *this << '\n');
-    mergeRangesForward(it);
-    DEBUG(std::cerr << "\t\t\t\tbefore merge backward: " << *this << '\n');
-    mergeRangesBackward(it);
+    it = mergeRangesForward(it);
+    it = mergeRangesBackward(it);
     DEBUG(std::cerr << "\t\t\t\tafter merging: " << *this << '\n');
 }
 
-void LiveIntervals::Interval::mergeRangesForward(Ranges::iterator it)
+void LiveIntervals::Interval::join(const LiveIntervals::Interval& other)
+{
+    DEBUG(std::cerr << "\t\t\t\tjoining intervals: "
+          << other << " and " << *this << '\n');
+    Ranges::iterator cur = ranges.begin();
+
+    for (Ranges::const_iterator i = other.ranges.begin(),
+             e = other.ranges.end(); i != e; ++i) {
+        cur = ranges.insert(std::upper_bound(cur, ranges.end(), *i), *i);
+        cur = mergeRangesForward(cur);
+        cur = mergeRangesBackward(cur);
+    }
+    if (MRegisterInfo::isVirtualRegister(reg))
+        weight += other.weight;
+
+    DEBUG(std::cerr << "\t\t\t\tafter merging: " << *this << '\n');
+}
+
+LiveIntervals::Interval::Ranges::iterator
+LiveIntervals::Interval::mergeRangesForward(Ranges::iterator it)
 {
     for (Ranges::iterator next = it + 1;
          next != ranges.end() && it->second >= next->first; ) {
         it->second = std::max(it->second, next->second);
         next = ranges.erase(next);
     }
+    return it;
 }
 
-void LiveIntervals::Interval::mergeRangesBackward(Ranges::iterator it)
+LiveIntervals::Interval::Ranges::iterator
+LiveIntervals::Interval::mergeRangesBackward(Ranges::iterator it)
 {
-    for (Ranges::iterator prev = it - 1;
-         it != ranges.begin() && it->first <= prev->second; ) {
+    while (it != ranges.begin()) {
+        Ranges::iterator prev = it - 1;
+        if (it->first > prev->second) break;
+
         it->first = std::min(it->first, prev->first);
         it->second = std::max(it->second, prev->second);
         it = ranges.erase(prev);
-        prev = it - 1;
-    }
-}
-
-bool LiveIntervals::Interval::liveAt(unsigned index) const
-{
-    Ranges::const_iterator r = ranges.begin();
-    while (r != ranges.end() && index < r->second) {
-        if (index >= r->first)
-            return true;
-        ++r;
-    }
-    return false;
-}
-
-bool LiveIntervals::Interval::overlaps(const Interval& other) const
-{
-    Ranges::const_iterator i = ranges.begin();
-    Ranges::const_iterator j = other.ranges.begin();
-
-    while (i != ranges.end() && j != other.ranges.end()) {
-        if (i->first < j->first) {
-            if (i->second > j->first) {
-                return true;
-            }
-            else {
-                ++i;
-            }
-        }
-        else if (j->first < i->first) {
-            if (j->second > i->first) {
-                return true;
-            }
-            else {
-                ++j;
-            }
-        }
-        else {
-            return true;
-        }
     }
 
-    return false;
+    return it;
 }
 
 std::ostream& llvm::operator<<(std::ostream& os,
@@ -420,7 +586,7 @@ std::ostream& llvm::operator<<(std::ostream& os,
     os << "%reg" << li.reg << ',' << li.weight << " = ";
     for (LiveIntervals::Interval::Ranges::const_iterator
              i = li.ranges.begin(), e = li.ranges.end(); i != e; ++i) {
-        os << "[" << i->first << "," << i->second << "]";
+        os << "[" << i->first << "," << i->second << ")";
     }
     return os;
 }