diff --git a/Code/Mantid/Framework/DataHandling/CMakeLists.txt b/Code/Mantid/Framework/DataHandling/CMakeLists.txt
index 61ddb8a9674aed907ddd1d1c0740ebea012b5b27..b30cecbd4b99cb5e4e3a490e8c9560d64ce558aa 100644
--- a/Code/Mantid/Framework/DataHandling/CMakeLists.txt
+++ b/Code/Mantid/Framework/DataHandling/CMakeLists.txt
@@ -84,7 +84,6 @@ set ( SRC_FILES
 	src/LoadSpec.cpp
 	src/LoadSpice2D.cpp
 	src/LoadTOFRawNexus.cpp
-	src/ManagedRawFileWorkspace2D.cpp
 	src/MaskDetectors.cpp
 	src/MaskDetectorsInShape.cpp
 	src/MergeLogs.cpp
@@ -212,7 +211,6 @@ set ( INC_FILES
 	inc/MantidDataHandling/LoadSpec.h
 	inc/MantidDataHandling/LoadSpice2D.h
 	inc/MantidDataHandling/LoadTOFRawNexus.h
-	inc/MantidDataHandling/ManagedRawFileWorkspace2D.h
 	inc/MantidDataHandling/MaskDetectors.h
 	inc/MantidDataHandling/MaskDetectorsInShape.h
 	inc/MantidDataHandling/MergeLogs.h
@@ -336,7 +334,6 @@ set ( TEST_FILES
 	LoadSpice2dTest.h
 	LoadTOFRawNexusTest.h
 	LoadTest.h
-	ManagedRawFileWorkspace2DTest.h
 	MaskDetectorsInShapeTest.h
 	MaskDetectorsTest.h
 	MergeLogsTest.h
diff --git a/Code/Mantid/Framework/DataHandling/inc/MantidDataHandling/LoadRaw3.h b/Code/Mantid/Framework/DataHandling/inc/MantidDataHandling/LoadRaw3.h
index 4b64e76fe145d5d75d86d190e8d15f3fcc51e3fe..49998b8b11e2d6ce81a3f508391517008927dd16 100644
--- a/Code/Mantid/Framework/DataHandling/inc/MantidDataHandling/LoadRaw3.h
+++ b/Code/Mantid/Framework/DataHandling/inc/MantidDataHandling/LoadRaw3.h
@@ -80,11 +80,6 @@ namespace Mantid
       void validateWorkspaceSizes( bool bexcludeMonitors ,bool bseparateMonitors,
           const int64_t normalwsSpecs,const int64_t  monitorwsSpecs);
 
-      /// this method will be executed if not enough memory.
-      void goManagedRaw(bool bincludeMonitors,bool bexcludeMonitors,
-          bool bseparateMonitors,const std::string& fileName);
-
-
       /// This method is useful for separating  or excluding   monitors from the output workspace
       void  separateOrexcludeMonitors(DataObjects::Workspace2D_sptr localWorkspace,
           bool binclude,bool bexclude,bool bseparate,
diff --git a/Code/Mantid/Framework/DataHandling/inc/MantidDataHandling/ManagedRawFileWorkspace2D.h b/Code/Mantid/Framework/DataHandling/inc/MantidDataHandling/ManagedRawFileWorkspace2D.h
deleted file mode 100644
index 91d72011c19dab3448e31e554cd59248b4ceaaf8..0000000000000000000000000000000000000000
--- a/Code/Mantid/Framework/DataHandling/inc/MantidDataHandling/ManagedRawFileWorkspace2D.h
+++ /dev/null
@@ -1,114 +0,0 @@
-#ifndef MANTID_DATAOBJECTS_MANAGEDRAWFILEWORKSPACE2D_H_
-#define MANTID_DATAOBJECTS_MANAGEDRAWFILEWORKSPACE2D_H_
-
-//----------------------------------------------------------------------
-// Includes
-//----------------------------------------------------------------------
-#include "MantidDataObjects/ManagedWorkspace2D.h"
-#include "MantidKernel/System.h"
-#include <Poco/Mutex.h>
-#include "MantidGeometry/IDetector.h"
-
-class ISISRAW2;
-
-namespace Mantid
-{
-
-//----------------------------------------------------------------------
-// Forward declarations
-//----------------------------------------------------------------------
-
-namespace DataHandling
-{
-/** \class ManagedRawFileWorkspace2D
-
-    Concrete workspace implementation. Data is a vector of Histogram1D.
-    Since Histogram1D have share ownership of X, Y or E arrays,
-    duplication is avoided for workspaces for example with identical time bins.
-
-    \author 
-    \date 
-
-    Copyright &copy; 2007-9 ISIS Rutherford Appleton Laboratory & NScD Oak Ridge National Laboratory
-
-    This file is part of Mantid.
-
-    Mantid 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 3 of the License, or
-    (at your option) any later version.
-
-    Mantid 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 General Public License for more details.
-
-    You should have received a copy of the GNU General Public License
-    along with this program.  If not, see <http://www.gnu.org/licenses/>.
-
-    File change history is stored at: <https://github.com/mantidproject/mantid>.
-    Code Documentation is available at: <http://doxygen.mantidproject.org>
-*/
-class DLLExport ManagedRawFileWorkspace2D : public DataObjects::ManagedWorkspace2D
-{
-public:
-  /**
-  Gets the name of the workspace type
-  @return Standard string name
-   */
-  virtual const std::string id() const {return "ManagedRawFileWorkspace2D";}
-
-  explicit ManagedRawFileWorkspace2D(const std::string& fileName, int opt=0);
-  virtual ~ManagedRawFileWorkspace2D();
- 
-protected:
-  /// Reads in a data block.
-  virtual void readDataBlock(DataObjects::ManagedDataBlock2D *newBlock,size_t startIndex)const;
-  /// Saves the dropped data block to disk.
-  virtual void writeDataBlock(DataObjects::ManagedDataBlock2D *toWrite) const;
-
-private:
-  /// Private copy constructor. NO COPY ALLOWED
-  ManagedRawFileWorkspace2D(const ManagedRawFileWorkspace2D&);
-  /// Private copy assignment operator. NO ASSIGNMENT ALLOWED
-  ManagedRawFileWorkspace2D& operator=(const ManagedRawFileWorkspace2D&);
-
-  /// Sets the RAW file for this workspace. Called by the constructor.
-  void setRawFile(const int opt);
-  void getTimeChannels();
-  bool needCache(const int opt);
-  void openTempFile();
-  void removeTempFile()const;
-  /// returns true if the given spectrum index is a monitor
-  bool isMonitor(const detid_t readIndex) const;
-
-  boost::shared_ptr<ISISRAW2> isisRaw;        ///< Pointer to an ISISRAW2 object
-  const std::string m_filenameRaw;///< RAW file name.
-  FILE* m_fileRaw;          ///< RAW file pointer.
-  fpos_t m_data_pos;        ///< Position in the file where the data start.
-  mutable int m_readIndex;  ///< Index of the spectrum which starts at current position in the file (== index_of_last_read + 1)
-  std::vector<boost::shared_ptr<MantidVec> > m_timeChannels; ///< Time bins
-  std::map<int64_t,int64_t> m_specTimeRegimes;   ///< Stores the time regime for each spectrum
-
-  // For each data block holds true if it has been modified and must read from ManagedWorkspace2D flat file
-  // of false if it must be read from the RAW file.
-  // The block's index = startIndex / m_vectorsPerBlock.
-  mutable std::vector<bool> m_changedBlock;  ///< Flags for modified blocks. Modified blocks are accessed through ManagedWorkspace2D interface
-  static int64_t g_uniqueID;             ///< Counter used to create unique file names
-  std::string m_tempfile;            ///< The temporary file name
-
-  int64_t m_numberOfTimeChannels;  ///< The number of time channels (i.e. bins) from the RAW file
-  int64_t m_numberOfBinBoundaries; ///< The number of time bin boundaries == m_numberOfTimeChannels + 1
-  int64_t m_numberOfSpectra;       ///< The number of spectra in the raw file
-  int64_t m_numberOfPeriods;       ///< The number of periods in the raw file
-
-  mutable Poco::FastMutex m_mutex;  ///< The mutex
-
-  /// a counter used for skipping the raw file if it's a monitor
-  mutable int64_t m_nmonitorSkipCounter;
- 
-};
-
-} // namespace DataHandling
-} // Namespace Mantid
-#endif /*MANTID_DATAOBJECTS_MANAGEDRAWFILEWORKSPACE2D_H_*/
diff --git a/Code/Mantid/Framework/DataHandling/src/LoadRaw3.cpp b/Code/Mantid/Framework/DataHandling/src/LoadRaw3.cpp
index 4c62bce0bd31dbe0db66ea90af72e4af4ee36aa2..559df364766e2cb0cb3b7e4ad07ac27857a3a094 100644
--- a/Code/Mantid/Framework/DataHandling/src/LoadRaw3.cpp
+++ b/Code/Mantid/Framework/DataHandling/src/LoadRaw3.cpp
@@ -24,7 +24,6 @@ LoadRaw version 1 and 2 are no longer available in Mantid.  Version 3 has been v
 // Includes
 //----------------------------------------------------------------------
 #include "MantidDataHandling/LoadRaw3.h"
-#include "MantidDataHandling/ManagedRawFileWorkspace2D.h"
 #include "MantidDataObjects/Workspace2D.h"
 #include "MantidGeometry/Instrument/XMLlogfile.h"
 #include "MantidAPI/MemoryManager.h"
@@ -140,16 +139,6 @@ namespace Mantid
       // Calculate the size of a workspace, given its number of periods & spectra to read
       m_total_specs = calculateWorkspaceSize();
 
-      // If there is not enough memory use ManagedRawFileWorkspace2D.
-      if ( ConfigService::Instance().getString("ManagedRawFileWorkspace.DoNotUse") != "1" &&
-          m_numberOfPeriods == 1 && m_total_specs == m_numberOfSpectra &&
-          MemoryManager::Instance().goForManagedWorkspace(m_total_specs,m_lengthIn, m_lengthIn-1) )
-      {
-        fclose(file);
-        goManagedRaw(bincludeMonitors, bexcludeMonitors, bseparateMonitors,m_filename);
-        return;
-      }
-
       // Get the time channel array(s) and store in a vector inside a shared pointer
       m_timeChannelsVec =getTimeChannels(m_noTimeRegimes,m_lengthIn);
 
@@ -584,59 +573,6 @@ namespace Mantid
       return bMonitor;
     }
 
-    /// Creates a ManagedRawFileWorkspace2D
-    /// @param bincludeMonitors :: Include monitors or not
-    /// @param bexcludeMonitors :: Exclude monitors or not
-    /// @param bseparateMonitors :: Separate monitors or not
-    /// @param fileName :: the filename
-    void LoadRaw3::goManagedRaw(bool bincludeMonitors, bool bexcludeMonitors, bool bseparateMonitors,
-        const std::string& fileName)
-    {
-      const std::string cache_option = getPropertyValue("Cache");
-      bool bLoadlogFiles = getProperty("LoadLogFiles");
-      size_t option = find(m_cache_options.begin(), m_cache_options.end(), cache_option)
-        - m_cache_options.begin();
-      progress(m_prog, "Reading raw file data...");
-      DataObjects::Workspace2D_sptr localWorkspace = DataObjects::Workspace2D_sptr(
-          new ManagedRawFileWorkspace2D(fileName, static_cast<int>(option)));
-      setProg( 0.2 );
-      progress(m_prog);
-      loadRunParameters(localWorkspace);
-      setProg( 0.4 );
-      progress(m_prog);
-      runLoadInstrument(fileName,localWorkspace, 0.2, 0.4 );
-      setProg( 0.5 );
-      progress(m_prog);
-      // Since all spectra are being loaded if we get to here,
-      // we can just set the spectrum numbers to start at 1 and increase monotonically
-      for (int i = 0; i < m_numberOfSpectra; ++i)
-      {
-        localWorkspace->getSpectrum(i)->setSpectrumNo(i+1);
-      }
-      setProg( 0.6 );
-      progress(m_prog);
-      runLoadMappingTable(fileName,localWorkspace);
-      setProg( 0.7 );
-      progress(m_prog);
-      if (bLoadlogFiles)
-      {
-        runLoadLog(fileName,localWorkspace, 0.5, 0.7);
-        const int current_period = 1;
-        createPeriodLogs(current_period,localWorkspace);
-      }
-      setProtonCharge(localWorkspace->mutableRun());
-
-      setProg( 0.8 );
-      progress(m_prog);
-      localWorkspace->populateInstrumentParameters();
-      setProg( 0.9 );
-      separateOrexcludeMonitors(localWorkspace, bincludeMonitors, bexcludeMonitors,
-          bseparateMonitors,m_numberOfSpectra,fileName);
-      setProg( 1.0 );
-      progress(m_prog);
-      setProperty("OutputWorkspace", boost::dynamic_pointer_cast<Workspace>(localWorkspace));
-    }
-
     /** This method separates/excludes monitors from output workspace and creates a separate workspace for monitors
      *  THIS METHOD IS ONLY CALLED BY THE goManagedRaw METHOD ABOVE AND NOT IN THE GENERAL CASE
      *  @param localWorkspace :: shared pointer to workspace
diff --git a/Code/Mantid/Framework/DataHandling/src/ManagedRawFileWorkspace2D.cpp b/Code/Mantid/Framework/DataHandling/src/ManagedRawFileWorkspace2D.cpp
deleted file mode 100644
index 8bfb50911b6a060c6f0257bedca5fe55c55dfb1d..0000000000000000000000000000000000000000
--- a/Code/Mantid/Framework/DataHandling/src/ManagedRawFileWorkspace2D.cpp
+++ /dev/null
@@ -1,368 +0,0 @@
-#include "MantidDataHandling/ManagedRawFileWorkspace2D.h"
-#include "MantidKernel/Exception.h"
-#include "MantidAPI/RefAxis.h"
-#include "MantidAPI/WorkspaceProperty.h"
-#include "MantidAPI/WorkspaceFactory.h"
-#include "MantidKernel/UnitFactory.h"
-#include "MantidKernel/ConfigService.h"
-#include "MantidKernel/System.h"
-
-#include "LoadRaw/isisraw2.h"
-#include <cstdio>
-#include <boost/timer.hpp>
-#include <Poco/File.h>
-#include <Poco/Path.h>
-#include <Poco/Exception.h>
-#include "MantidDataObjects/ManagedHistogram1D.h"
-
-using Mantid::DataObjects::ManagedHistogram1D;
-
-//DECLARE_WORKSPACE(ManagedRawFileWorkspace2D)
-
-namespace Mantid
-{
-  namespace DataHandling
-  {
-    namespace
-    {
-      // Get a reference to the logger
-      Kernel::Logger g_log("ManagedRawFileWorkspace2D");
-    }
-
-    // Initialise the instance count
-    int64_t ManagedRawFileWorkspace2D::g_uniqueID = 1;
-
-    /// Constructor
-    ManagedRawFileWorkspace2D::ManagedRawFileWorkspace2D(const std::string& fileName, int opt) :
-      ManagedWorkspace2D(),
-      isisRaw(new ISISRAW2),m_filenameRaw(fileName),m_fileRaw(NULL),m_readIndex(0),m_nmonitorSkipCounter(0)
-    {
-      this->setRawFile(opt);
-    }
-
-    ///Destructor
-    ManagedRawFileWorkspace2D::~ManagedRawFileWorkspace2D()
-    {
-      if (m_fileRaw) fclose(m_fileRaw);
-      removeTempFile();
-    }
-
-    /** Sets the RAW file for this workspace.
-        @param opt :: Caching option.  0 - cache on local drive if raw file is very slow to read.
-        1 - cache anyway, 2 - never cache.
-    */
-    void ManagedRawFileWorkspace2D::setRawFile(const int opt)
-    {
-      m_fileRaw = fopen(m_filenameRaw.c_str(),"rb");
-      if (m_fileRaw == NULL)
-      {
-        throw Kernel::Exception::FileError("Unable to open File:" , m_filenameRaw);
-      }
-
-      if ( needCache(opt) )
-      {
-        openTempFile();
-      }
-
-      isisRaw->ioRAW(m_fileRaw, true);
-
-      m_numberOfBinBoundaries = isisRaw->t_ntc1 + 1;    
-      m_numberOfPeriods = isisRaw->t_nper;
-      initialize(isisRaw->t_nsp1,m_numberOfBinBoundaries,isisRaw->t_ntc1);
-      int64_t noOfBlocks = m_noVectors / m_vectorsPerBlock;
-      if ( noOfBlocks * m_vectorsPerBlock != m_noVectors ) ++noOfBlocks;
-      m_changedBlock.resize(noOfBlocks,false);
-
-      isisRaw->skipData(m_fileRaw,0);
-      fgetpos(m_fileRaw, &m_data_pos); //< Save the data start position.
-
-      getTimeChannels();
-      getAxis(0)->unit() = Kernel::UnitFactory::Instance().create("TOF");
-      setYUnit("Counts");
-      setTitle(std::string(isisRaw->r_title, 80));
-    }
-
-    /// Constructs the time channel (X) vector(s)
-    void ManagedRawFileWorkspace2D::getTimeChannels()
-    {
-      float* const timeChannels = new float[m_numberOfBinBoundaries];
-      isisRaw->getTimeChannels(timeChannels, static_cast<int>(m_numberOfBinBoundaries));
-
-      const int regimes = isisRaw->daep.n_tr_shift;
-      if ( regimes >=2 )
-      {
-        g_log.debug() << "Raw file contains " << regimes << " time regimes\n"; 
-        // If more than 1 regime, create a timeChannelsVec for each regime
-        for (int i=0; i < regimes; ++i)
-        {
-          // Create a vector with the 'base' time channels
-          boost::shared_ptr<MantidVec> channelsVec(
-            new MantidVec(timeChannels,timeChannels + m_numberOfBinBoundaries));
-          const double shift = isisRaw->daep.tr_shift[i];
-          g_log.debug() << "Time regime " << i+1 << " shifted by " << shift << " microseconds\n";
-          // Add on the shift for this vector
-          std::transform(channelsVec->begin(), channelsVec->end(),
-                         channelsVec->begin(), std::bind2nd(std::plus<double>(),shift));
-          m_timeChannels.push_back(channelsVec);
-        }
-        // In this case, also need to populate the map of spectrum-regime correspondence
-        const int64_t ndet = static_cast<int64_t>(isisRaw->i_det);
-        std::map<int64_t,int64_t>::iterator hint = m_specTimeRegimes.begin();
-        for (int64_t j=0; j < ndet; ++j)
-        {
-          // No checking for consistency here - that all detectors for given spectrum
-          // are declared to use same time regime. Will just use first encountered
-          hint = m_specTimeRegimes.insert(hint,std::make_pair(isisRaw->spec[j],isisRaw->timr[j]));
-        }
-      }
-      else // Just need one in this case
-      {
-        boost::shared_ptr<MantidVec> channelsVec(
-          new MantidVec(timeChannels,timeChannels + m_numberOfBinBoundaries));
-        m_timeChannels.push_back(channelsVec);
-      }
-      // Done with the timeChannels C array so clean up
-      delete[] timeChannels;
-    }
-
-    // Pointer to sqrt function (used in calculating errors below)
-    typedef double (*uf)(double);
-    static uf dblSqrt = std::sqrt;
-
-    // readData(int) should be changed to readNextSpectrum() returning the spectrum index
-    // and skipData to skipNextSpectrum()
-    void ManagedRawFileWorkspace2D::readDataBlock(DataObjects::ManagedDataBlock2D *newBlock,size_t startIndex)const
-    {
-      Poco::ScopedLock<Poco::FastMutex> mutex(m_mutex);
-      if (!m_fileRaw)
-      {
-        g_log.error("Raw file was not open.");
-        throw std::runtime_error("Raw file was not open.");
-      }
-      int64_t blockIndex = startIndex / m_vectorsPerBlock;
-
-      // Modified data is stored in ManagedWorkspace2D flat file.
-      if (m_changedBlock[blockIndex])
-      {
-        ManagedWorkspace2D::readDataBlock(newBlock,startIndex);
-        return;
-      }
-
-      if(m_monitorList.size()>0)
-      { 
-        if ( static_cast<int>(startIndex) > m_readIndex)
-        {
-          while(static_cast<int>(startIndex) >  m_readIndex-m_nmonitorSkipCounter)
-          {
-            isisRaw->skipData(m_fileRaw,m_readIndex+1);// Adding 1 because we dropped the first spectrum.
-            ++m_readIndex;
-            if(isMonitor(m_readIndex))
-              ++m_nmonitorSkipCounter;
-          }
-        }
-        else
-        {
-          int nwords = 0;
-          while(static_cast<int>(startIndex)+ m_nmonitorSkipCounter+1 <  m_readIndex)
-          {
-            if(isMonitor(m_readIndex))
-              --m_nmonitorSkipCounter;
-            --m_readIndex;
-            nwords += 4*isisRaw->ddes[m_readIndex+1].nwords;
-          }
-          if (fseek(m_fileRaw,-nwords,SEEK_CUR) != 0)
-          {
-            fclose(m_fileRaw);
-            removeTempFile();
-            g_log.error("Error reading RAW file.");
-            throw std::runtime_error("ManagedRawFileWorkspace2D: Error reading RAW file.");
-          }
-        }
-        int64_t endIndex = startIndex+m_vectorsPerBlock < m_noVectors?startIndex+m_vectorsPerBlock:m_noVectors;
-        if (endIndex >= static_cast<int64_t>(m_noVectors)) endIndex = static_cast<int64_t>(m_noVectors);
-        int64_t index=startIndex;
-        while(index<endIndex)
-        {
-          if(isMonitor(m_readIndex))
-          {     isisRaw->skipData(m_fileRaw,m_readIndex+1);
-            //g_log.error()<<"skipData called for monitor index"<<m_readIndex<<std::endl;
-            ++m_nmonitorSkipCounter;
-            ++m_readIndex;
-          }
-          else
-          {
-            isisRaw->readData(m_fileRaw,m_readIndex+1);
-            //g_log.error()<<"readData called for spectrum index"<<m_readIndex<< " and wsIndex is "<<index<< std::endl;
-            if( m_readIndex == static_cast<int64_t>(m_noVectors+m_monitorList.size()) )
-              break;
-
-            // The managed histogram we are modifying
-            ManagedHistogram1D * spec = dynamic_cast<ManagedHistogram1D *>(newBlock->getSpectrum(index));
-
-            MantidVec& y = spec->directDataY();
-            y.assign(isisRaw->dat1 + 1, isisRaw->dat1 + m_numberOfBinBoundaries);  
-            //g_log.error()<<"readData called for m_readIndex"<<m_readIndex<< " and wsIndex is "<<index<< "Y value at 0  column is "<<y[0]<<std::endl;
-            MantidVec& e = spec->directDataE();
-            e.resize(y.size(), 0);
-            std::transform(y.begin(), y.end(), e.begin(), dblSqrt);
-            if (m_timeChannels.size() == 1)
-              spec->directSetX(m_timeChannels[0]);
-            else
-            {
-              // std::map<int,int>::const_iterator regime = m_specTimeRegimes.find(index+1);
-              std::map<int64_t,int64_t>::const_iterator regime = m_specTimeRegimes.find(m_readIndex+1);
-              if ( regime == m_specTimeRegimes.end() ) 
-              {
-                g_log.error() << "Spectrum " << index << " not present in spec array:\n";
-                g_log.error(" Assuming time regime of spectrum 1");
-                regime = m_specTimeRegimes.begin();
-              }
-              spec->directSetX(m_timeChannels[(*regime).second-1]);
-            }
-            spec->setLoaded(true);
-            ++index;
-            ++m_readIndex;
-          }
-        }
- 
-      }
-      else
-      { 
-        if ( static_cast<int>(startIndex) > m_readIndex)
-        {
-          while( static_cast<int>(startIndex) > m_readIndex)
-          {
-            isisRaw->skipData(m_fileRaw,m_readIndex+1);// Adding 1 because we dropped the first spectrum.
-            ++m_readIndex;
-          }
-        }
-        else
-        {
-          int nwords = 0;
-          while( static_cast<int>(startIndex) < m_readIndex)
-          {                      
-            --m_readIndex;
-            nwords += 4*isisRaw->ddes[m_readIndex+1].nwords;
-          }
-          if (fseek(m_fileRaw,-nwords,SEEK_CUR) != 0)
-          {
-            fclose(m_fileRaw);
-            removeTempFile();
-            g_log.error("Error reading RAW file.");
-            throw std::runtime_error("ManagedRawFileWorkspace2D: Error reading RAW file.");
-          }
-        }
-        int64_t endIndex = startIndex+m_vectorsPerBlock < m_noVectors?startIndex+m_vectorsPerBlock:m_noVectors;
-        if (endIndex >=  static_cast<int64_t>(m_noVectors)) endIndex = m_noVectors;
-        for(int64_t index = startIndex;index<endIndex;index++,m_readIndex++)
-        {
-          isisRaw->readData(m_fileRaw,m_readIndex+1);
-          // g_log.error()<<"counter is "<<counter<<std::endl;
-
-          // The managed histogram we are modifying
-          ManagedHistogram1D * spec = dynamic_cast<ManagedHistogram1D *>(newBlock->getSpectrum(index));
-
-          MantidVec& y = spec->directDataY();
-          y.assign(isisRaw->dat1 + 1, isisRaw->dat1 + m_numberOfBinBoundaries);   
-          MantidVec& e = spec->directDataE();
-          e.resize(y.size(), 0);
-          std::transform(y.begin(), y.end(), e.begin(), dblSqrt);
-          if (m_timeChannels.size() == 1)
-            spec->directSetX(m_timeChannels[0]);
-          else
-          {
-            std::map<int64_t,int64_t>::const_iterator regime = m_specTimeRegimes.find(index+1);
-            if ( regime == m_specTimeRegimes.end() ) 
-            {
-              g_log.error() << "Spectrum " << index << " not present in spec array:\n";
-              g_log.error(" Assuming time regime of spectrum 1");
-              regime = m_specTimeRegimes.begin();
-            }
-            spec->directSetX(m_timeChannels[(*regime).second-1]);
-          }
-          spec->setLoaded(true);
-        }
-      }
-
-      newBlock->hasChanges(false);
-      newBlock->setLoaded(true);
-    }
-    /** This method checks given spectrum is a monitor
-     * @param readIndex :: a spectrum index
-     * @return true if it's a monitor ,otherwise false
-     */
-    bool ManagedRawFileWorkspace2D::isMonitor(const specid_t readIndex)const
-    {
-      std::vector<specid_t>::const_iterator itr;
-      for(itr=m_monitorList.begin();itr!=m_monitorList.end();++itr)
-      {
-        if((*itr)==readIndex)
-          return true;
-      }
-      return false;
-    }
-
-    void ManagedRawFileWorkspace2D::writeDataBlock(DataObjects::ManagedDataBlock2D *toWrite) const
-    {
-      Poco::ScopedLock<Poco::FastMutex> mutex(m_mutex);
-      // ManagedWorkspace2D resets the hasChanges flag but we need to make sure we keep track of it here as well
-      const bool blockHasChanged = toWrite->hasChanges();
-      ManagedWorkspace2D::writeDataBlock(toWrite);
-      int blockIndex = static_cast<int>(toWrite->minIndex() / m_vectorsPerBlock);
-      m_changedBlock[blockIndex] = blockHasChanged;
-    }
-
-    /**
-       Decides if the raw file must be copied to a cache file on the local drive to improve reading time.
-    */
-    bool ManagedRawFileWorkspace2D::needCache(const int opt)
-    {
-      if (opt == 1) return true;
-      if (opt == 2) return false;
-
-      return Kernel::ConfigService::Instance().isNetworkDrive(m_filenameRaw);
-    }
-
-    /**   Opens a temporary file
-     */
-    void ManagedRawFileWorkspace2D::openTempFile()
-    {
-      // Look for the (optional) path from the configuration file
-      std::string path = Kernel::ConfigService::Instance().getString("ManagedWorkspace.FilePath");
-      if( path.empty() || !Poco::File(path).exists() || !Poco::File(path).canWrite() )
-      {
-        path = Mantid::Kernel::ConfigService::Instance().getUserPropertiesDir();
-        g_log.debug() << "Temporary file written to " << path << std::endl;
-      }
-      if ( ( *(path.rbegin()) != '/' ) && ( *(path.rbegin()) != '\\' ) )
-      {
-        path.push_back('/');
-      }
-
-      std::stringstream filename;
-      filename << "WS2D_" << Poco::Path(m_filenameRaw).getBaseName() <<'_'<< ManagedRawFileWorkspace2D::g_uniqueID <<".raw";
-      // Increment the instance count
-      ++ManagedRawFileWorkspace2D::g_uniqueID;
-      m_tempfile = path + filename.str();
-      Poco::File(m_filenameRaw).copyTo(m_tempfile);
-
-      FILE *fileRaw = fopen(m_tempfile.c_str(),"rb");
-      if (fileRaw)
-      {
-        fclose(m_fileRaw);
-        m_fileRaw = fileRaw;
-      }
-
-    }
-
-    /**   Removes the temporary file
-     */
-    void ManagedRawFileWorkspace2D::removeTempFile() const
-    {
-      if (!m_tempfile.empty()) Poco::File(m_tempfile).remove();
-    }
-        
-
-  } // namespace DataHandling
-} //NamespaceMantid
-
diff --git a/Code/Mantid/Framework/DataHandling/test/ManagedRawFileWorkspace2DTest.h b/Code/Mantid/Framework/DataHandling/test/ManagedRawFileWorkspace2DTest.h
deleted file mode 100644
index 4dd1c931a3098ad80deb7188274dd1d2ef533793..0000000000000000000000000000000000000000
--- a/Code/Mantid/Framework/DataHandling/test/ManagedRawFileWorkspace2DTest.h
+++ /dev/null
@@ -1,300 +0,0 @@
-#ifndef ManagedRawFileWorkspace2DTEST_H_
-#define ManagedRawFileWorkspace2DTEST_H_
-
-#include "MantidAPI/FileFinder.h"
-#include "MantidAPI/IAlgorithm.h"
-#include "MantidDataHandling/LoadRaw3.h"
-#include "MantidDataHandling/ManagedRawFileWorkspace2D.h"
-#include "MantidGeometry/Instrument/Detector.h"
-#include "MantidKernel/ConfigService.h"
-#include "MantidKernel/TimeSeriesProperty.h"
-#include <cxxtest/TestSuite.h>
-
-using Mantid::MantidVec;
-using namespace Mantid;
-using namespace Mantid::API;
-using namespace Mantid::DataHandling;
-using namespace Mantid::DataObjects;
-using namespace Mantid::Kernel;
-
-class ManagedRawFileWorkspace2DTest : public CxxTest::TestSuite
-{
-public:
-
-  static ManagedRawFileWorkspace2DTest *createSuite() { return new ManagedRawFileWorkspace2DTest(); }
-  static void destroySuite(ManagedRawFileWorkspace2DTest *suite) { delete suite; }
-
-  ManagedRawFileWorkspace2DTest()
-  {
-    file = FileFinder::Instance().getFullPath("HET15869.raw");
-    Workspace = new ManagedRawFileWorkspace2D(file,2);
-  }
-
-  virtual ~ManagedRawFileWorkspace2DTest()
-  {
-    delete Workspace;
-  }
-
-  void testSetFile()
-  {
-    TS_ASSERT_EQUALS( Workspace->getNumberHistograms(), 2584 )
-    TS_ASSERT_EQUALS( Workspace->blocksize(), 1675 )
-    TS_ASSERT_EQUALS( Workspace->size(), 4328200 )
-    
-    TS_ASSERT_THROWS_NOTHING( Workspace->readX(0) )
-  }
-
-  void testCast()
-  {
-    TS_ASSERT( dynamic_cast<ManagedWorkspace2D*>(Workspace) )
-    TS_ASSERT( dynamic_cast<Workspace2D*>(Workspace) )
-    TS_ASSERT( dynamic_cast<Mantid::API::Workspace*>(Workspace) )
-  }
-
-  void testId()
-  {
-    TS_ASSERT( ! Workspace->id().compare("ManagedRawFileWorkspace2D") )
-  }
-
-  void testData()
-  {
-    ManagedRawFileWorkspace2D ws(file);
-
-    const MantidVec& x0 = ws.readX(0);
-    TS_ASSERT_EQUALS( x0[0], 5. )
-    TS_ASSERT_EQUALS( x0[10], 7.5 )
-    const MantidVec& x100 = ws.readX(100);
-    TS_ASSERT_EQUALS( x100[0], 5. )
-    TS_ASSERT_EQUALS( x100[10], 7.5 )
-
-    const MantidVec& y0 = ws.readY(0);
-    TS_ASSERT_EQUALS( y0[0], 0. )
-    TS_ASSERT_EQUALS( y0[10], 1. )
-    const MantidVec& y100 = ws.readY(100);
-    TS_ASSERT_EQUALS( y100[0], 1. )
-    TS_ASSERT_EQUALS( y100[10], 1. )
-
-  }
-
-  void testChanges()
-  {
-    ManagedRawFileWorkspace2D ws(file);
-    // Need to ensure that the number of writes is greater than the MRUList size
-    // so that we check the read/write from the file
-    // There is no public API to find the size so this will have to do.
-    const size_t nhist = 400;
-    for(size_t i = 0; i < nhist; ++i)
-    {
-      MantidVec& y0 = ws.dataY(i);
-      y0[0] = 100.0;
-    }
-    
-    // Check that we have actually changed it
-    for(size_t i = 0; i < nhist; ++i)
-    {
-      const MantidVec& y0 = ws.readY(i);
-      const std::string msg = "The first value at index " + boost::lexical_cast<std::string>(i) + " does not have the expected value.";
-      TSM_ASSERT_EQUALS(msg, y0[0], 100.0 );
-    }
-  }
-
-  // Test is taken from LoadRawTest
-  void testLoadRaw3()
-  {
-    // Make sure we go managed
-    ConfigServiceImpl& conf = ConfigService::Instance();
-    const std::string managed = "ManagedWorkspace.LowerMemoryLimit";
-    const std::string oldValue = conf.getString(managed);
-    conf.setString(managed,"0");
-    const std::string managed2 = "ManagedRawFileWorkspace.DoNotUse";
-    const std::string oldValue2 = conf.getString(managed2);
-    conf.setString(managed2,"0");
-
-    LoadRaw3 loader;
-    if ( !loader.isInitialized() ) loader.initialize();
-
-    // Should fail because mandatory parameter has not been set
-    TS_ASSERT_THROWS(loader.execute(),std::runtime_error);
-
-      std::string    inputFile = "HET15869.raw";
-
-    // Now set it...
-    loader.setPropertyValue("Filename", inputFile);
-
-    std::string outputSpace = "outer";
-    loader.setPropertyValue("OutputWorkspace", outputSpace);
-
-    TS_ASSERT_THROWS_NOTHING(loader.execute());
-    TS_ASSERT( loader.isExecuted() );
-
-    // Get back the saved workspace
-    Workspace_sptr output;
-    TS_ASSERT_THROWS_NOTHING(output = AnalysisDataService::Instance().retrieve(outputSpace));
-    Workspace2D_const_sptr output2D = boost::dynamic_pointer_cast<const Workspace2D>(output);
-    TS_ASSERT(boost::dynamic_pointer_cast<const ManagedRawFileWorkspace2D>(output2D) )
-    // Should be 2584 for file HET15869.RAW
-    TS_ASSERT_EQUALS( output2D->getNumberHistograms(), 2584);
-    // Check two X vectors are the same
-    TS_ASSERT( (output2D->dataX(99)) == (output2D->dataX(1734)) );
-    // Check two Y arrays have the same number of elements
-    TS_ASSERT_EQUALS( output2D->dataY(673).size(), output2D->dataY(2111).size() );
-    // Check one particular value
-    TS_ASSERT_EQUALS( output2D->dataY(999)[777], 9);
-    // Check that the error on that value is correct
-    TS_ASSERT_EQUALS( output2D->dataE(999)[777], 3);
-    // Check that the error on that value is correct
-    TS_ASSERT_EQUALS( output2D->dataX(999)[777], 554.1875);
-
-    // Check the unit has been set correctly
-    TS_ASSERT_EQUALS( output2D->getAxis(0)->unit()->unitID(), "TOF" )
-    TS_ASSERT( ! output2D-> isDistribution() )
-
-    // Check the proton charge has been set correctly
-    TS_ASSERT_DELTA( output2D->run().getProtonCharge(), 171.0353, 0.0001 )
-
-    //----------------------------------------------------------------------
-    // Tests taken from LoadInstrumentTest to check Child Algorithm is running properly
-    //----------------------------------------------------------------------
-    boost::shared_ptr<const Mantid::Geometry::Instrument> i = output2D->getInstrument();
-    boost::shared_ptr<const Mantid::Geometry::IComponent> source = i->getSource();
-
-    TS_ASSERT_EQUALS( source->getName(), "undulator");
-    TS_ASSERT_DELTA( source->getPos().Y(), 0.0,0.01);
-
-    boost::shared_ptr<const Mantid::Geometry::IComponent> samplepos = i->getSample();
-    TS_ASSERT_EQUALS( samplepos->getName(), "nickel-holder");
-    TS_ASSERT_DELTA( samplepos->getPos().Z(), 0.0,0.01);
-
-    boost::shared_ptr<const Mantid::Geometry::Detector> ptrDet103 = boost::dynamic_pointer_cast<const Mantid::Geometry::Detector>(i->getDetector(103));
-    TS_ASSERT_EQUALS( ptrDet103->getID(), 103);
-    TS_ASSERT_EQUALS( ptrDet103->getName(), "pixel");
-    TS_ASSERT_DELTA( ptrDet103->getPos().X(), 0.4013,0.01);
-    TS_ASSERT_DELTA( ptrDet103->getPos().Z(), 2.4470,0.01);
-
-    //----------------------------------------------------------------------
-    // Test code copied from LoadLogTest to check Child Algorithm is running properly
-    //----------------------------------------------------------------------
-   // boost::shared_ptr<Sample> sample = output2D->getSample();
-    Property *l_property = output2D->run().getLogData( std::string("TEMP1") );
-    TimeSeriesProperty<double> *l_timeSeriesDouble = dynamic_cast<TimeSeriesProperty<double>*>(l_property);
-    std::string timeSeriesString = l_timeSeriesDouble->value();
-    TS_ASSERT_EQUALS( timeSeriesString.substr(0,23), "2007-Nov-13 15:16:20  0" );
-
-    //----------------------------------------------------------------------
-    // Tests to check that spectra-detector mapping is done correctly
-    //----------------------------------------------------------------------
-    // Test one to one mapping, for example spectra 6 has only 1 pixel
-    TS_ASSERT_EQUALS( output2D->getSpectrum(6)->getDetectorIDs().size(), 1);   // rummap.ndet(6),1);
-
-    // Test one to many mapping, for example 10 pixels contribute to spectra 2084 (workspace index 2083)
-    TS_ASSERT_EQUALS( output2D->getSpectrum(2083)->getDetectorIDs().size(), 10);   //map.ndet(2084),10);
-
-    // Check the id number of all pixels contributing
-    std::set<detid_t> detectorgroup;
-    detectorgroup = output2D->getSpectrum(2083)->getDetectorIDs();
-    std::set<detid_t>::const_iterator it;
-    int pixnum=101191;
-    for (it=detectorgroup.begin();it!=detectorgroup.end();it++)
-      TS_ASSERT_EQUALS(*it,pixnum++);
-
-    //----------------------------------------------------------------------
-    // Test new-style spectrum/detector number retrieval
-    //----------------------------------------------------------------------
-    // Just test a few....
-    TS_ASSERT_EQUALS( output2D->getAxis(1)->spectraNo(0), 1 );
-    TS_ASSERT_EQUALS( output2D->getSpectrum(0)->getSpectrumNo(), 1 );
-    TS_ASSERT( output2D->getSpectrum(0)->hasDetectorID(601) );
-    TS_ASSERT_EQUALS( output2D->getDetector(0)->getID(), 601);
-    TS_ASSERT_EQUALS( output2D->getAxis(1)->spectraNo(1500), 1501 );
-    TS_ASSERT_EQUALS( output2D->getSpectrum(1500)->getSpectrumNo(), 1501 );
-    TS_ASSERT( output2D->getSpectrum(1500)->hasDetectorID(405049) );
-    TS_ASSERT_EQUALS( output2D->getDetector(1500)->getID(), 405049);
-    TS_ASSERT_EQUALS( output2D->getAxis(1)->spectraNo(2580), 2581 );
-    TS_ASSERT_EQUALS( output2D->getSpectrum(2580)->getSpectrumNo(), 2581 );
-    TS_ASSERT( output2D->getSpectrum(2580)->hasDetectorID(310217) );
-    TS_ASSERT_EQUALS( output2D->getDetector(2580)->getID(), 310217);
-
-    AnalysisDataService::Instance().remove(outputSpace);
-    conf.setString(managed,oldValue);
-    conf.setString(managed2,oldValue2);
-  }
-
-private:
-  ManagedRawFileWorkspace2D* Workspace;
-  std::string file;
-};
-
-////------------------------------------------------------------------------------
-//// Performance test
-////------------------------------------------------------------------------------
-//
-//class NOTATEST : public CxxTest::TestSuite
-//{
-//private:
-//  const std::string outputSpace;
-//
-//public:
-//  // This pair of boilerplate methods prevent the suite being created statically
-//  // This means the constructor isn't called when running other tests
-//  static NOTATEST *createSuite() { return new NOTATEST(); }
-//  static void destroySuite( NOTATEST *suite ) { delete suite; }
-//
-//  NOTATEST() : outputSpace("wishWS")
-//  {
-//    // Load the instrument alone so as to isolate the raw file loading time from the instrument loading time
-//    IAlgorithm * loader = FrameworkManager::Instance().createAlgorithm("LoadEmptyInstrument");
-//    loader->setPropertyValue("Filename","WISH_Definition.xml");
-//    loader->setPropertyValue("OutputWorkspace", "InstrumentOnly");
-//    TS_ASSERT( loader->execute() );
-//  }
-//
-//  // This should take ~no time. If it does an unacceptable change has occurred!
-//  void testLoadTime()
-//  {
-//    // Make sure we go managed
-//    ConfigServiceImpl& conf = ConfigService::Instance();
-//    const std::string managed = "ManagedWorkspace.LowerMemoryLimit";
-//    const std::string oldValue = conf.getString(managed);
-//    conf.setString(managed,"0");
-//    const std::string managed2 = "ManagedRawFileWorkspace.DoNotUse";
-//    const std::string oldValue2 = conf.getString(managed2);
-//    conf.setString(managed2,"0");
-//    const std::string datapath = "datasearch.directories";
-//    std::string pathValue = conf.getString(datapath);
-//    pathValue.append(";../../Data/SystemTests/");
-//    conf.setString(datapath,pathValue);
-//
-//    IAlgorithm * loader = FrameworkManager::Instance().createAlgorithm("LoadRaw");
-//    //IAlgorithm_sptr loader = AlgorithmFactory::Instance().create("LoadRaw");
-//    loader->setPropertyValue("Filename","WISH00016748.raw");
-//    loader->setPropertyValue("OutputWorkspace",outputSpace);
-//    TS_ASSERT( loader->execute() );
-//
-//    conf.setString(managed,oldValue);
-//    conf.setString(managed2,oldValue2);
-//  }
-//
-//  // This also should be very quick (nothing should get written to disk)
-//  void testReadValues()
-//  {
-//    MatrixWorkspace_const_sptr ws = AnalysisDataService::Instance().retrieveWS<const MatrixWorkspace>(outputSpace);
-//    TS_ASSERT( ws );
-//
-//    double x(0),y(0),e(0);
-//    for ( std::size_t i = 0 ; i < ws->getNumberHistograms() ; ++i )
-//    {
-//      x = ws->readX(i)[0];
-//      y = ws->readY(i)[0];
-//      e = ws->readE(i)[0];
-//    }
-//
-//    TS_ASSERT( x > 0.0 );
-//    TS_ASSERT( y == 0.0 );
-//    TS_ASSERT( e == 0.0 );
-//
-//    AnalysisDataService::Instance().remove(outputSpace);
-//  }
-//
-//};
-
-#endif /*ManagedRawFileWorkspace2DTEST_H_*/
diff --git a/Code/Mantid/Framework/Properties/Mantid.properties.template b/Code/Mantid/Framework/Properties/Mantid.properties.template
index 9d0fec2b105d292ea6832a78520f641054a842d4..9aa0919a994628e3cf02c11c490178d0290a7a3b 100644
--- a/Code/Mantid/Framework/Properties/Mantid.properties.template
+++ b/Code/Mantid/Framework/Properties/Mantid.properties.template
@@ -108,8 +108,6 @@ ManagedWorkspace.LowerMemoryLimit = 80
 ManagedWorkspace.AlwaysInMemory = 0
 ManagedWorkspace.DataBlockSize = 4000
 ManagedWorkspace.FilePath = 
-# Setting this to 1 will disable managedrawfileworkspaces
-ManagedRawFileWorkspace.DoNotUse = 0
 
 # Defines the maximum number of cores to use for OpenMP
 # For machine default set to 0
diff --git a/Code/Mantid/Framework/PythonInterface/mantid/api/src/Exports/MatrixWorkspace.cpp b/Code/Mantid/Framework/PythonInterface/mantid/api/src/Exports/MatrixWorkspace.cpp
index 5fb31fb4f80ded278b69d0a5513dc7ad1fbc221d..73714e1afa3c5dfefa107436ab6d0fe7aa3af68f 100644
--- a/Code/Mantid/Framework/PythonInterface/mantid/api/src/Exports/MatrixWorkspace.cpp
+++ b/Code/Mantid/Framework/PythonInterface/mantid/api/src/Exports/MatrixWorkspace.cpp
@@ -239,10 +239,10 @@ void export_MatrixWorkspace()
   
   //-------------------------------------------------------------------------------------------------
 
-  static const int NUM_IDS = 9;
+  static const int NUM_IDS = 8;
   static const char * WORKSPACE_IDS[NUM_IDS] = {\
       "GroupingWorkspace", "ManagedWorkspace2D",
-      "ManagedRawFileWorkspace2D", "MaskWorkspace", "OffsetsWorkspace",
+      "MaskWorkspace", "OffsetsWorkspace",
       "RebinnedOutput", "SpecialWorkspace2D", "Workspace2D", "WorkspaceSingleValue"
   };
 
diff --git a/Code/Mantid/MantidPlot/src/Mantid/WorkspaceIcons.cpp b/Code/Mantid/MantidPlot/src/Mantid/WorkspaceIcons.cpp
index eed7f0725b6fe981fbc514f8748b3e8f17b1c0e9..92dad1d753ef2c3e6f38055b5dc9147611bc7360 100644
--- a/Code/Mantid/MantidPlot/src/Mantid/WorkspaceIcons.cpp
+++ b/Code/Mantid/MantidPlot/src/Mantid/WorkspaceIcons.cpp
@@ -41,7 +41,6 @@ void WorkspaceIcons::initInternalLookup()
   m_idToPixmapName["EventWorkspace"] = "mantid_matrix_xpm";
   m_idToPixmapName["GroupingWorkspace"] = "mantid_matrix_xpm";
   m_idToPixmapName["ManagedWorkspace2D"] = "mantid_matrix_xpm";
-  m_idToPixmapName["ManagedRawFileWorkspace2D"] = "mantid_matrix_xpm";
   m_idToPixmapName["MaskWorkspace"] = "mantid_matrix_xpm";
   m_idToPixmapName["OffsetsWorkspace"] = "mantid_matrix_xpm";
   m_idToPixmapName["RebinnedOutput"] = "mantid_matrix_xpm";