module GHC.HeapView (
GenClosure(..),
Closure,
allPtrs,
ClosureType(..),
StgInfoTable(..),
HalfWord,
getClosureData,
getBoxedClosureData,
getClosureRaw,
ppClosure,
HeapTree(..),
buildHeapTree,
ppHeapTree,
HeapGraphEntry(..),
HeapGraphIndex,
HeapGraph(..),
lookupHeapGraph,
heapGraphRoot,
buildHeapGraph,
multiBuildHeapGraph,
addHeapGraph,
annotateHeapGraph,
updateHeapGraph,
ppHeapGraph,
Box(..),
asBox,
areBoxesEqual,
disassembleBCO,
)
where
import GHC.Exts ( Any,
Ptr(..), Addr#, Int(..), Word(..), Word#, Int#,
ByteArray#, Array#, sizeofByteArray#, sizeofArray#, indexArray#, indexWordArray#,
unsafeCoerce# )
import GHC.Arr (Array(..))
import Foreign hiding ( void )
import Numeric ( showHex )
import Data.Char
import Data.List
import Data.Maybe ( catMaybes )
import Data.Monoid ( Monoid, (<>), mempty )
import Data.Functor
import Data.Function
import Data.Foldable ( Foldable )
import qualified Data.Foldable as F
import Data.Traversable ( Traversable )
import qualified Data.Traversable as T
import qualified Data.IntMap as M
import Control.Monad
import Control.Monad.Trans.State
import Control.Monad.Trans.Class
import Control.Monad.IO.Class
import Control.Monad.Trans.Writer.Strict
import Control.Exception.Base (evaluate)
import GHC.Disassembler
#include "ghcautoconf.h"
data Box = Box Any
#if SIZEOF_VOID_P == 8
type HalfWord = Word32
#else
type HalfWord = Word16
#endif
instance Show Box where
showsPrec _ (Box a) rs =
pad_out (showHex addr "") ++ (if tag>0 then "/" ++ show tag else "") ++ rs
where
ptr = W# (aToWord# a)
tag = ptr .&. fromIntegral tAG_MASK
addr = ptr tag
pad_out ls =
'0':'x':(replicate (2*wORD_SIZE length ls) '0') ++ ls
areBoxesEqual :: Box -> Box -> IO Bool
areBoxesEqual (Box a) (Box b) = case reallyUnsafePtrEqualityUpToTag# a b of
0# -> return False
_ -> return True
asBox :: a -> Box
asBox x = Box (unsafeCoerce# x)
data StgInfoTable = StgInfoTable {
ptrs :: HalfWord,
nptrs :: HalfWord,
tipe :: ClosureType,
srtlen :: HalfWord
}
deriving (Show)
instance Storable StgInfoTable where
sizeOf itbl
= sum
[
fieldSz ptrs itbl,
fieldSz nptrs itbl,
sizeOf (undefined :: HalfWord),
fieldSz srtlen itbl
]
alignment _
= wORD_SIZE
poke _a0 _itbl
= error "Storable StgInfoTable is read-only"
peek a0
= flip (evalStateT) (castPtr a0)
$ do
ptrs' <- load
nptrs' <- load
tipe' <- load
srtlen' <- load
return
StgInfoTable {
ptrs = ptrs',
nptrs = nptrs',
tipe = toEnum (fromIntegral (tipe'::HalfWord)),
srtlen = srtlen'
}
fieldSz :: Storable b => (a -> b) -> a -> Int
fieldSz sel x = sizeOf (sel x)
load :: Storable a => PtrIO a
load = do addr <- advance
lift (peek addr)
type PtrIO = StateT (Ptr Word8) IO
advance :: Storable a => PtrIO (Ptr a)
advance = StateT adv where
adv addr = case castPtr addr of { addrCast -> return
(addrCast, addr `plusPtr` sizeOfPointee addrCast) }
sizeOfPointee :: (Storable a) => Ptr a -> Int
sizeOfPointee addr = sizeOf (typeHack addr)
where typeHack = undefined :: Ptr a -> a
data ClosureType =
INVALID_OBJECT
| CONSTR
| CONSTR_1_0
| CONSTR_0_1
| CONSTR_2_0
| CONSTR_1_1
| CONSTR_0_2
#if defined(GHC_8_0)
| CONSTR_STATIC
| CONSTR_NOCAF_STATIC
#else
| CONSTR_NOCAF
#endif
| FUN
| FUN_1_0
| FUN_0_1
| FUN_2_0
| FUN_1_1
| FUN_0_2
| FUN_STATIC
| THUNK
| THUNK_1_0
| THUNK_0_1
| THUNK_2_0
| THUNK_1_1
| THUNK_0_2
| THUNK_STATIC
| THUNK_SELECTOR
| BCO
| AP
| PAP
| AP_STACK
| IND
#if defined(GHC_8_0)
| IND_PERM
#endif
| IND_STATIC
| RET_BCO
| RET_SMALL
| RET_BIG
| RET_FUN
| UPDATE_FRAME
| CATCH_FRAME
| UNDERFLOW_FRAME
| STOP_FRAME
| BLOCKING_QUEUE
| BLACKHOLE
| MVAR_CLEAN
| MVAR_DIRTY
| TVAR
| ARR_WORDS
| MUT_ARR_PTRS_CLEAN
| MUT_ARR_PTRS_DIRTY
| MUT_ARR_PTRS_FROZEN0
| MUT_ARR_PTRS_FROZEN
| MUT_VAR_CLEAN
| MUT_VAR_DIRTY
| WEAK
| PRIM
| MUT_PRIM
| TSO
| STACK
| TREC_CHUNK
| ATOMICALLY_FRAME
| CATCH_RETRY_FRAME
| CATCH_STM_FRAME
| WHITEHOLE
| SMALL_MUT_ARR_PTRS_CLEAN
| SMALL_MUT_ARR_PTRS_DIRTY
| SMALL_MUT_ARR_PTRS_FROZEN0
| SMALL_MUT_ARR_PTRS_FROZEN
#if defined(GHC_8_2)
| COMPACT_NFDATA
#endif
deriving (Show, Eq, Enum, Bounded, Ord)
data GenClosure b =
ConsClosure {
info :: StgInfoTable
, ptrArgs :: [b]
, dataArgs :: [Word]
, pkg :: String
, modl :: String
, name :: String
} |
ThunkClosure {
info :: StgInfoTable
, ptrArgs :: [b]
, dataArgs :: [Word]
} |
SelectorClosure {
info :: StgInfoTable
, selectee :: b
} |
IndClosure {
info :: StgInfoTable
, indirectee :: b
} |
BlackholeClosure {
info :: StgInfoTable
, indirectee :: b
} |
APClosure {
info :: StgInfoTable
, arity :: HalfWord
, n_args :: HalfWord
, fun :: b
, payload :: [b]
} |
PAPClosure {
info :: StgInfoTable
, arity :: HalfWord
, n_args :: HalfWord
, fun :: b
, payload :: [b]
} |
APStackClosure {
info :: StgInfoTable
, fun :: b
, payload :: [b]
} |
BCOClosure {
info :: StgInfoTable
, instrs :: b
, literals :: b
, bcoptrs :: b
, arity :: HalfWord
, size :: HalfWord
, bitmap :: Word
} |
ArrWordsClosure {
info :: StgInfoTable
, bytes :: Word
, arrWords :: [Word]
} |
MutArrClosure {
info :: StgInfoTable
, mccPtrs :: Word
, mccSize :: Word
, mccPayload :: [b]
} |
MutVarClosure {
info :: StgInfoTable
, var :: b
} |
MVarClosure {
info :: StgInfoTable
, queueHead :: b
, queueTail :: b
, value :: b
} |
FunClosure {
info :: StgInfoTable
, ptrArgs :: [b]
, dataArgs :: [Word]
} |
BlockingQueueClosure {
info :: StgInfoTable
, link :: b
, blackHole :: b
, owner :: b
, queue :: b
} |
OtherClosure {
info :: StgInfoTable
, hvalues :: [b]
, rawWords :: [Word]
} |
UnsupportedClosure {
info :: StgInfoTable
}
deriving (Show, Functor, Foldable, Traversable)
type Closure = GenClosure Box
allPtrs :: GenClosure b -> [b]
allPtrs (ConsClosure {..}) = ptrArgs
allPtrs (ThunkClosure {..}) = ptrArgs
allPtrs (SelectorClosure {..}) = [selectee]
allPtrs (IndClosure {..}) = [indirectee]
allPtrs (BlackholeClosure {..}) = [indirectee]
allPtrs (APClosure {..}) = fun:payload
allPtrs (PAPClosure {..}) = fun:payload
allPtrs (APStackClosure {..}) = fun:payload
allPtrs (BCOClosure {..}) = [instrs,literals,bcoptrs]
allPtrs (ArrWordsClosure {..}) = []
allPtrs (MutArrClosure {..}) = mccPayload
allPtrs (MutVarClosure {..}) = [var]
allPtrs (MVarClosure {..}) = [queueHead,queueTail,value]
allPtrs (FunClosure {..}) = ptrArgs
allPtrs (BlockingQueueClosure {..}) = [link, blackHole, owner, queue]
allPtrs (OtherClosure {..}) = hvalues
allPtrs (UnsupportedClosure {..}) = []
#ifdef PRIM_SUPPORTS_ANY
foreign import prim "aToWordzh" aToWord# :: Any -> Word#
foreign import prim "slurpClosurezh" slurpClosure# :: Any -> (# Addr#, ByteArray#, Array# b #)
foreign import prim "reallyUnsafePtrEqualityUpToTag" reallyUnsafePtrEqualityUpToTag# :: Any -> Any -> Int#
#else
foreign import prim "slurpClosurezh" slurpClosure'# :: Word# -> (# Addr#, ByteArray#, Array# b #)
foreign import prim "reallyUnsafePtrEqualityUpToTag" reallyUnsafePtrEqualityUpToTag'# :: Word# -> Word# -> Int#
data Ptr' a = Ptr' a
aToWord# :: Any -> Word#
aToWord# a = case Ptr' a of mb@(Ptr' _) -> case unsafeCoerce# mb :: Word of W# addr -> addr
slurpClosure# :: Any -> (# Addr#, ByteArray#, Array# b #)
slurpClosure# a = slurpClosure'# (aToWord# a)
reallyUnsafePtrEqualityUpToTag# :: Any -> Any -> Int#
reallyUnsafePtrEqualityUpToTag# a b = reallyUnsafePtrEqualityUpToTag'# (aToWord# a) (aToWord# b)
#endif
getClosureRaw :: a -> IO (Ptr StgInfoTable, [Word], [Box])
getClosureRaw x =
case slurpClosure# (unsafeCoerce# x) of
(# iptr, dat, ptrs #) -> do
let nelems = (I# (sizeofByteArray# dat)) `div` wORD_SIZE
rawWords = [W# (indexWordArray# dat i) | I# i <- [0.. fromIntegral nelems 1] ]
pelems = I# (sizeofArray# ptrs)
ptrList = amap' Box $ Array 0 (pelems 1) pelems ptrs
mapM_ evaluate ptrList
void $ evaluate nelems
mapM_ evaluate rawWords
return (Ptr iptr, rawWords, ptrList)
amap' :: (t -> b) -> Array Int t -> [b]
amap' f (Array i0 i _ arr#) = map g [0 .. i i0]
where g (I# i#) = case indexArray# arr# i# of
(# e #) -> f e
dataConInfoPtrToNames :: Ptr StgInfoTable -> IO (String, String, String)
dataConInfoPtrToNames ptr = do
conDescAddress <- getConDescAddress ptr
wl <- peekArray0 0 conDescAddress
let (pkg, modl, name) = parse wl
return (b2s pkg, b2s modl, b2s name)
where
b2s :: [Word8] -> String
b2s = fmap (chr . fromIntegral)
getConDescAddress :: Ptr StgInfoTable -> IO (Ptr Word8)
getConDescAddress ptr'
| True = do
offsetToString <- peek (ptr' `plusPtr` (negate wORD_SIZE))
return $ (ptr' `plusPtr` stdInfoTableSizeB)
`plusPtr` (fromIntegral (offsetToString :: Word))
opt_SccProfilingOn = False
stdInfoTableSizeW :: Int
stdInfoTableSizeW
= size_fixed + size_prof
where
size_fixed = 2
size_prof | opt_SccProfilingOn = 2
| otherwise = 0
stdInfoTableSizeB :: Int
stdInfoTableSizeB = stdInfoTableSizeW * wORD_SIZE
parse :: [Word8] -> ([Word8], [Word8], [Word8])
parse input = if not . all (>0) . fmap length $ [pkg,modl,occ]
then ([], [], input)
else (pkg, modl, occ)
where
(pkg, rest1) = break (== fromIntegral (ord ':')) input
(modl, occ)
= (concat $ intersperse [dot] $ reverse modWords, occWord)
where
(modWords, occWord) = if (length rest1 < 1)
then parseModOcc [] []
else parseModOcc [] (tail rest1)
dot = fromIntegral (ord '.')
parseModOcc :: [[Word8]] -> [Word8] -> ([[Word8]], [Word8])
parseModOcc acc str
= case break (== dot) str of
(top, []) -> (acc, top)
(top, _:bot) -> parseModOcc (top : acc) bot
getClosureData :: a -> IO Closure
getClosureData x = do
(iptr, wds, ptrs) <- getClosureRaw x
itbl <- peek iptr
case tipe itbl of
t | t >= CONSTR
#if defined(GHC_8_0)
, t <= CONSTR_NOCAF_STATIC
#else
, t <= CONSTR_NOCAF
#endif
-> do
(pkg, modl, name) <- dataConInfoPtrToNames iptr
if modl == "ByteCodeInstr" && name == "BreakInfo"
then return $ UnsupportedClosure itbl
else return $ ConsClosure itbl ptrs (drop (length ptrs + 1) wds) pkg modl name
t | t >= THUNK && t <= THUNK_STATIC -> do
return $ ThunkClosure itbl ptrs (drop (length ptrs + 2) wds)
t | t >= FUN && t <= FUN_STATIC -> do
return $ FunClosure itbl ptrs (drop (length ptrs + 1) wds)
AP -> do
unless (length ptrs >= 1) $
fail "Expected at least 1 ptr argument to AP"
unless (length wds >= 3) $
fail "Expected at least 3 raw words to AP"
return $ APClosure itbl
(fromIntegral $ wds !! 2)
(fromIntegral $ shiftR (wds !! 2) (wORD_SIZE_IN_BITS `div` 2))
(head ptrs) (tail ptrs)
PAP -> do
unless (length ptrs >= 1) $
fail "Expected at least 1 ptr argument to PAP"
unless (length wds >= 3) $
fail "Expected at least 3 raw words to AP"
return $ PAPClosure itbl
(fromIntegral $ wds !! 2)
(fromIntegral $ shiftR (wds !! 2) (wORD_SIZE_IN_BITS `div` 2))
(head ptrs) (tail ptrs)
AP_STACK -> do
unless (length ptrs >= 1) $
fail "Expected at least 1 ptr argument to AP_STACK"
return $ APStackClosure itbl (head ptrs) (tail ptrs)
THUNK_SELECTOR -> do
unless (length ptrs >= 1) $
fail "Expected at least 1 ptr argument to THUNK_SELECTOR"
return $ SelectorClosure itbl (head ptrs)
IND -> do
unless (length ptrs >= 1) $
fail "Expected at least 1 ptr argument to IND"
return $ IndClosure itbl (head ptrs)
IND_STATIC -> do
unless (length ptrs >= 1) $
fail "Expected at least 1 ptr argument to IND_STATIC"
return $ IndClosure itbl (head ptrs)
BLACKHOLE -> do
unless (length ptrs >= 1) $
fail "Expected at least 1 ptr argument to BLACKHOLE"
return $ BlackholeClosure itbl (head ptrs)
BCO -> do
unless (length ptrs >= 3) $
fail $ "Expected at least 3 ptr argument to BCO, found " ++ show (length ptrs)
unless (length wds >= 6) $
fail $ "Expected at least 6 words to BCO, found " ++ show (length wds)
return $ BCOClosure itbl (ptrs !! 0) (ptrs !! 1) (ptrs !! 2)
(fromIntegral $ wds !! 4)
(fromIntegral $ shiftR (wds !! 4) (wORD_SIZE_IN_BITS `div` 2))
(wds !! 5)
ARR_WORDS -> do
unless (length wds >= 2) $
fail $ "Expected at least 2 words to ARR_WORDS, found " ++ show (length wds)
return $ ArrWordsClosure itbl (wds !! 1) (drop 2 wds)
t | t == MUT_ARR_PTRS_FROZEN || t == MUT_ARR_PTRS_FROZEN0 -> do
unless (length wds >= 3) $
fail $ "Expected at least 3 words to MUT_ARR_PTRS_FROZEN0 found " ++ show (length wds)
return $ MutArrClosure itbl (wds !! 1) (wds !! 2) ptrs
t | t == MUT_VAR_CLEAN || t == MUT_VAR_DIRTY ->
return $ MutVarClosure itbl (head ptrs)
t | t == MVAR_CLEAN || t == MVAR_DIRTY -> do
unless (length ptrs >= 3) $
fail $ "Expected at least 3 ptrs to MVAR, found " ++ show (length ptrs)
return $ MVarClosure itbl (ptrs !! 0) (ptrs !! 1) (ptrs !! 2)
BLOCKING_QUEUE ->
return $ OtherClosure itbl ptrs wds
_ ->
return $ UnsupportedClosure itbl
getBoxedClosureData :: Box -> IO Closure
getBoxedClosureData (Box a) = getClosureData a
isChar :: GenClosure b -> Maybe Char
isChar (ConsClosure { name = "C#", dataArgs = [ch], ptrArgs = []}) = Just (chr (fromIntegral ch))
isChar _ = Nothing
isCons :: GenClosure b -> Maybe (b, b)
isCons (ConsClosure { name = ":", dataArgs = [], ptrArgs = [h,t]}) = Just (h,t)
isCons _ = Nothing
isTup :: GenClosure b -> Maybe [b]
isTup (ConsClosure { dataArgs = [], ..}) =
if length name >= 3 &&
head name == '(' && last name == ')' &&
all (==',') (tail (init name))
then Just ptrArgs else Nothing
isTup _ = Nothing
isNil :: GenClosure b -> Bool
isNil (ConsClosure { name = "[]", dataArgs = [], ptrArgs = []}) = True
isNil _ = False
ppClosure :: (Int -> b -> String) -> Int -> GenClosure b -> String
ppClosure showBox prec c = case c of
_ | Just ch <- isChar c -> app $
["C#", show ch]
_ | Just (h,t) <- isCons c -> addBraces (5 <= prec) $
showBox 5 h ++ " : " ++ showBox 4 t
_ | Just vs <- isTup c ->
"(" ++ intercalate "," (map (showBox 0) vs) ++ ")"
ConsClosure {..} -> app $
name : map (showBox 10) ptrArgs ++ map show dataArgs
ThunkClosure {..} -> app $
"_thunk" : map (showBox 10) ptrArgs ++ map show dataArgs
SelectorClosure {..} -> app
["_sel", showBox 10 selectee]
IndClosure {..} -> app
["_ind", showBox 10 indirectee]
BlackholeClosure {..} -> app
["_bh", showBox 10 indirectee]
APClosure {..} -> app $ map (showBox 10) $
fun : payload
PAPClosure {..} -> app $ map (showBox 10) $
fun : payload
APStackClosure {..} -> app $ map (showBox 10) $
fun : payload
BCOClosure {..} -> app
["_bco"]
ArrWordsClosure {..} -> app
["toArray", "("++show (length arrWords) ++ " words)", intercalate "," (shorten (map show arrWords)) ]
MutArrClosure {..} -> app
["toMutArray", "("++show (length mccPayload) ++ " ptrs)", intercalate "," (shorten (map (showBox 10) mccPayload))]
MutVarClosure {..} -> app $
["_mutVar", (showBox 10) var]
MVarClosure {..} -> app $
["MVar", (showBox 10) value]
FunClosure {..} ->
"_fun" ++ braceize (map (showBox 0) ptrArgs ++ map show dataArgs)
BlockingQueueClosure {..} ->
"_blockingQueue"
OtherClosure {..} ->
"_other"
UnsupportedClosure {..} ->
"_unsupported"
where
app [a] = a ++ "()"
app xs = addBraces (10 <= prec) (intercalate " " xs)
shorten xs = if length xs > 20 then take 20 xs ++ ["(and more)"] else xs
data HeapTree = HeapTree Box (GenClosure HeapTree) | EndOfHeapTree
heapTreeClosure :: HeapTree -> Maybe (GenClosure HeapTree)
heapTreeClosure (HeapTree _ c) = Just c
heapTreeClosure EndOfHeapTree = Nothing
buildHeapTree :: Int -> Box -> IO HeapTree
buildHeapTree 0 _ = do
return $ EndOfHeapTree
buildHeapTree n b = do
c <- getBoxedClosureData b
c' <- T.mapM (buildHeapTree (n1)) c
return $ HeapTree b c'
ppHeapTree :: HeapTree -> String
ppHeapTree = go 0
where
go _ EndOfHeapTree = "..."
go prec t@(HeapTree _ c')
| Just s <- isHeapTreeString t = show s
| Just l <- isHeapTreeList t = "[" ++ intercalate "," (map ppHeapTree l) ++ "]"
| Just bc <- disassembleBCO heapTreeClosure c'
= app ("_bco" : map (go 10) (concatMap F.toList bc))
| otherwise = ppClosure go prec c'
where
app [a] = a ++ "()"
app xs = addBraces (10 <= prec) (intercalate " " xs)
isHeapTreeList :: HeapTree -> Maybe ([HeapTree])
isHeapTreeList tree = do
c <- heapTreeClosure tree
if isNil c
then return []
else do
(h,t) <- isCons c
t' <- isHeapTreeList t
return $ (:) h t'
isHeapTreeString :: HeapTree -> Maybe String
isHeapTreeString t = do
list <- isHeapTreeList t
if (null list)
then Nothing
else mapM (isChar <=< heapTreeClosure) list
data HeapGraphEntry a = HeapGraphEntry {
hgeBox :: Box,
hgeClosure :: GenClosure (Maybe HeapGraphIndex),
hgeLive :: Bool,
hgeData :: a}
deriving (Show, Functor)
type HeapGraphIndex = Int
newtype HeapGraph a = HeapGraph (M.IntMap (HeapGraphEntry a))
deriving (Show)
lookupHeapGraph :: HeapGraphIndex -> (HeapGraph a) -> Maybe (HeapGraphEntry a)
lookupHeapGraph i (HeapGraph m) = M.lookup i m
heapGraphRoot :: HeapGraphIndex
heapGraphRoot = 0
buildHeapGraph
:: Monoid a
=> Int
-> a
-> Box
-> IO (HeapGraph a)
buildHeapGraph limit rootD initialBox =
fst <$> multiBuildHeapGraph limit [(rootD, initialBox)]
multiBuildHeapGraph
:: Monoid a
=> Int
-> [(a, Box)]
-> IO (HeapGraph a, [(a, HeapGraphIndex)])
multiBuildHeapGraph limit = generalBuildHeapGraph limit (HeapGraph M.empty)
addHeapGraph
:: Monoid a
=> Int
-> a
-> Box
-> HeapGraph a
-> IO (HeapGraphIndex, HeapGraph a)
addHeapGraph limit d box hg = do
(hg', [(_,i)]) <- generalBuildHeapGraph limit hg [(d,box)]
return (i, hg')
annotateHeapGraph :: Monoid a => a -> HeapGraphIndex -> HeapGraph a -> HeapGraph a
annotateHeapGraph d i (HeapGraph hg) = HeapGraph $ M.update go i hg
where
go hge = Just $ hge { hgeData = hgeData hge <> d }
generalBuildHeapGraph
:: Monoid a
=> Int
-> HeapGraph a
-> [(a,Box)]
-> IO (HeapGraph a, [(a, HeapGraphIndex)])
generalBuildHeapGraph limit _ _ | limit <= 0 = error "buildHeapGraph: limit has to be positive"
generalBuildHeapGraph limit (HeapGraph hg) addBoxes = do
let boxList = [ (hgeBox hge, i) | (i, hge) <- M.toList hg ]
indices | M.null hg = [0..]
| otherwise = [1 + fst (M.findMax hg)..]
initialState = (boxList, indices, [])
(is, hg') <- runWriterT (evalStateT run initialState)
let hg'' = foldl' (flip (uncurry annotateHeapGraph)) (HeapGraph hg') is
return (hg'', is)
where
run = do
lift $ tell hg
forM addBoxes $ \(d, b) -> do
Just i <- add limit b
return (d, i)
add 0 _ = return Nothing
add n b = do
(existing,_,_) <- get
mbI <- liftIO $ findM (areBoxesEqual b . fst) existing
case mbI of
Just (_,i) -> return $ Just i
Nothing -> do
i <- nextI
modify (\(x,y,z) -> ((b,i):x, y, z))
c <- liftIO $ getBoxedClosureData b
c' <- T.mapM (add (n1)) c
lift $ tell (M.singleton i (HeapGraphEntry b c' True mempty))
return $ Just i
nextI = do
i <- gets (head . (\(_,b,_) -> b))
modify (\(a,b,c) -> (a, tail b, c))
return i
updateHeapGraph :: Monoid a => Int -> HeapGraph a -> IO (HeapGraph a, HeapGraphIndex -> HeapGraphIndex)
updateHeapGraph limit (HeapGraph startHG) = do
(hg', indexMap) <- runWriterT $ foldM go (HeapGraph M.empty) (M.toList startHG)
return (hg', (M.!) indexMap)
where
go hg (i, hge) = do
(j, hg') <- liftIO $ addHeapGraph limit (hgeData hge) (hgeBox hge) hg
tell (M.singleton i j)
return hg'
ppHeapGraph :: HeapGraph a -> String
ppHeapGraph (HeapGraph m) = letWrapper ++ ppRef 0 (Just heapGraphRoot)
where
bindings = boundMultipleTimes (HeapGraph m) [heapGraphRoot]
letWrapper =
if null bindings
then ""
else "let " ++ intercalate "\n " (map ppBinding bindings) ++ "\nin "
bindingLetter i = case hgeClosure (iToE i) of
ThunkClosure {..} -> 't'
SelectorClosure {..} -> 't'
APClosure {..} -> 't'
PAPClosure {..} -> 'f'
BCOClosure {..} -> 't'
FunClosure {..} -> 'f'
_ -> 'x'
ppBindingMap = M.fromList $
concat $
map (zipWith (\j (i,c) -> (i, [c] ++ show j)) [(1::Int)..]) $
groupBy ((==) `on` snd) $
sortBy (compare `on` snd)
[ (i, bindingLetter i) | i <- bindings ]
ppVar i = ppBindingMap M.! i
ppBinding i = ppVar i ++ " = " ++ ppEntry 0 (iToE i)
ppEntry prec hge
| Just s <- isString hge = show s
| Just l <- isList hge = "[" ++ intercalate "," (map (ppRef 0) l) ++ "]"
| Just bc <- disassembleBCO (fmap (hgeClosure . iToE)) (hgeClosure hge)
= app ("_bco" : map (ppRef 10) (concatMap F.toList bc))
| otherwise = ppClosure ppRef prec (hgeClosure hge)
where
app [a] = a ++ "()"
app xs = addBraces (10 <= prec) (intercalate " " xs)
ppRef _ Nothing = "..."
ppRef prec (Just i) | i `elem` bindings = ppVar i
| otherwise = ppEntry prec (iToE i)
iToE i = m M.! i
iToUnboundE i = if i `elem` bindings then Nothing else M.lookup i m
isList :: HeapGraphEntry a -> Maybe ([Maybe HeapGraphIndex])
isList hge =
if isNil (hgeClosure hge)
then return []
else do
(h,t) <- isCons (hgeClosure hge)
ti <- t
e <- iToUnboundE ti
t' <- isList e
return $ (:) h t'
isString :: HeapGraphEntry a -> Maybe String
isString e = do
list <- isList e
if (null list)
then Nothing
else mapM (isChar . hgeClosure <=< iToUnboundE <=< id) list
boundMultipleTimes :: HeapGraph a -> [HeapGraphIndex] -> [HeapGraphIndex]
boundMultipleTimes (HeapGraph m) roots = map head $ filter (not.null) $ map tail $ group $ sort $
roots ++ concatMap (catMaybes . allPtrs . hgeClosure) (M.elems m)
disassembleBCO :: (a -> Maybe (GenClosure b)) -> GenClosure a -> Maybe [BCI b]
disassembleBCO deref (BCOClosure {..}) = do
opsC <- deref instrs
litsC <- deref literals
ptrsC <- deref bcoptrs
return $ disassemble (mccPayload ptrsC) (arrWords litsC) (toBytes (bytes opsC) (arrWords opsC))
disassembleBCO _ _ = Nothing
findM :: (a -> IO Bool) -> [a] -> IO (Maybe a)
findM _p [] = return Nothing
findM p (x:xs) = do
b <- p x
if b then return (Just x) else findM p xs
addBraces :: Bool -> String -> String
addBraces True t = "(" ++ t ++ ")"
addBraces False t = t
braceize :: [String] -> String
braceize [] = ""
braceize xs = "{" ++ intercalate "," xs ++ "}"
#include "MachDeps.h"
wORD_SIZE, tAG_MASK, wORD_SIZE_IN_BITS :: Int
wORD_SIZE = SIZEOF_HSWORD
tAG_MASK = (1 `shift` TAG_BITS) 1
wORD_SIZE_IN_BITS = WORD_SIZE_IN_BITS