style cleanyp

This commit is contained in:
2012-06-23 23:22:19 +00:00
parent 8ef4c4762b
commit 74c9c24d27
30 changed files with 331 additions and 326 deletions

View File

@@ -53,47 +53,47 @@
class CTR_UHeapable {
public :
int &
public:
int &
HeapPos(
) {
) {
return m_ind;
};
float &
float &
HeapKey(
) {
) {
return m_key;
};
const
float &
float &
HeapKey(
) const {
) const {
return m_key;
};
const
int &
int &
HeapPos(
) const {
) const {
return m_ind;
};
private :
private:
float m_key;
int m_ind;
protected :
protected:
CTR_UHeapable(
) : m_key (0),
m_ind (0)
) : m_key(0),
m_ind(0)
{
};
~CTR_UHeapable(
) {
) {
};
};
@@ -104,50 +104,50 @@ class CTR_UHeap : public MEM_NonCopyable
public:
static
CTR_UHeap *
CTR_UHeap *
New(
) {
) {
return new CTR_UHeap();
}
void
void
MakeHeap(
HeapType *base
) {
HeapType *base
) {
int i;
int start = Parent(m_vector.size()-1);
for (i = start; i >=0; --i) {
DownHeap(base,i);
int start = Parent(m_vector.size() - 1);
for (i = start; i >= 0; --i) {
DownHeap(base, i);
}
};
void
void
Insert(
HeapType *base,
int elem
) {
HeapType *base,
int elem
) {
// add element to vector
m_vector.push_back(elem);
base[elem].HeapPos() = m_vector.size()-1;
base[elem].HeapPos() = m_vector.size() - 1;
// push the element up the heap
UpHeap(base,m_vector.size()-1);
UpHeap(base, m_vector.size() - 1);
}
// access to the vector for initial loading of elements
std::vector<int> &
std::vector<int> &
HeapVector(
) {
) {
return m_vector;
};
void
void
Remove(
HeapType *base,
int i
) {
HeapType *base,
int i
) {
// exchange with last element - pop last
// element and move up or down the heap as appropriate
@@ -155,37 +155,38 @@ public:
assert(false);
}
if (i != int(m_vector.size())-1) {
if (i != int(m_vector.size()) - 1) {
Swap(base,i,m_vector.size() - 1);
Swap(base, i, m_vector.size() - 1);
m_vector.pop_back();
if (!m_vector.empty()) {
UpHeap(base,i);
DownHeap(base,i);
UpHeap(base, i);
DownHeap(base, i);
}
} else {
}
else {
m_vector.pop_back();
}
}
int
int
Top(
) const {
) const {
if (m_vector.empty()) return -1;
return m_vector[0];
}
void
void
SC_Heap(
HeapType *base
) {
HeapType *base
) {
int i;
for (i = 1; i < int(m_vector.size()) ; i++) {
for (i = 1; i < int(m_vector.size()); i++) {
CTR_UHeapable * elem = base + m_vector[i];
CTR_UHeapable * p_elem = base + m_vector[Parent(i)];
CTR_UHeapable *elem = base + m_vector[i];
CTR_UHeapable *p_elem = base + m_vector[Parent(i)];
assert(p_elem->HeapKey() >= elem->HeapKey());
assert(elem->HeapPos() == i);
@@ -195,27 +196,27 @@ public:
~CTR_UHeap(
) {
) {
};
private:
CTR_UHeap(
) {
) {
};
std::vector<int> m_vector;
private:
void
void
Swap(
HeapType *base,
int i,
int j
) {
std::swap(m_vector[i],m_vector[j]);
HeapType *base,
int i,
int j
) {
std::swap(m_vector[i], m_vector[j]);
CTR_UHeapable *heap_i = base + m_vector[i];
CTR_UHeapable *heap_j = base + m_vector[j];
@@ -225,77 +226,78 @@ private:
heap_j->HeapPos() = j;
}
int
int
Parent(
unsigned int i
) {
return (i-1) >> 1;
unsigned int i
) {
return (i - 1) >> 1;
}
int
int
Left(
int i
) {
return (i<<1)+1;
int i
) {
return (i << 1) + 1;
}
int
int
Right(
int i
) {
return (i<<1)+2;
int i
) {
return (i << 1) + 2;
}
float
float
HeapVal(
HeapType *base,
int i
) {
HeapType *base,
int i
) {
return base[m_vector[i]].HeapKey();
}
void
void
DownHeap(
HeapType *base,
int i
) {
HeapType *base,
int i
) {
int heap_size = m_vector.size();
int l = Left(i);
int r = Right(i);
int largest;
if (l < heap_size && HeapVal(base,l) > HeapVal(base,i)) {
if (l < heap_size && HeapVal(base, l) > HeapVal(base, i)) {
largest = l;
} else {
}
else {
largest = i;
}
if (r < heap_size && HeapVal(base,r) > HeapVal(base,largest)) {
if (r < heap_size && HeapVal(base, r) > HeapVal(base, largest)) {
largest = r;
}
if (largest != i) {
// exchange i and largest
Swap(base,i,largest);
DownHeap(base,largest);
Swap(base, i, largest);
DownHeap(base, largest);
}
}
void
void
UpHeap(
HeapType *base,
int i
) {
HeapType *base,
int i
) {
// swap parents untill it's found a place in the heap < it's parent or
// top of heap
while (i > 0) {
int p = Parent(i);
if (HeapVal(base,i) < HeapVal(base,p)) {
if (HeapVal(base, i) < HeapVal(base, p)) {
break;
}
Swap(base,p,i);
Swap(base, p, i);
i = p;
}
}

View File

@@ -61,7 +61,7 @@ GHOST_SystemPathsX11::~GHOST_SystemPathsX11()
const GHOST_TUns8 *GHOST_SystemPathsX11::getSystemDir(int, const char *versionstr) const
{
/* no prefix assumes a portable build which only uses bundled scripts */
if(static_path) {
if (static_path) {
static char system_path[PATH_MAX];
snprintf(system_path, sizeof(system_path), "%s/blender/%s", static_path, versionstr);
return (GHOST_TUns8*)system_path;
@@ -76,10 +76,10 @@ const GHOST_TUns8 *GHOST_SystemPathsX11::getUserDir(int version, const char *ver
/* in blender 2.64, we migrate to XDG. to ensure the copy previous settings
* operator works we give a different path depending on the requested version */
if(version < 264) {
if (version < 264) {
const char *home = getenv("HOME");
if(home) {
if (home) {
snprintf(user_path, sizeof(user_path), "%s/.blender/%s", home, versionstr);
return (GHOST_TUns8*)user_path;
}

View File

@@ -1882,7 +1882,7 @@ static void ccgSubSurf__calcSubdivLevel(CCGSubSurf *ss,
VertDataMulN(q, 0.25f, ss);
VertDataAdd(r, q, ss);
/* nCo = nCo + (r - nCo) * avgSharpness */
/* nCo = nCo + (r - nCo) * avgSharpness */
VertDataSub(r, nCo, ss);
VertDataMulN(r, avgSharpness, ss);
VertDataAdd(nCo, r, ss);
@@ -2331,7 +2331,7 @@ static void ccgSubSurf__sync(CCGSubSurf *ss)
VertDataMulN(q, 0.25f, ss);
VertDataAdd(r, q, ss);
/* nCo = nCo + (r - nCo) * avgSharpness */
/* nCo = nCo + (r - nCo) * avgSharpness */
VertDataSub(r, nCo, ss);
VertDataMulN(r, avgSharpness, ss);
VertDataAdd(nCo, r, ss);

View File

@@ -106,7 +106,7 @@ static void cloth_apply_vgroup ( ClothModifierData *clmd, DerivedMesh *dm );
*
******************************************************************************/
/**
* cloth_init - creates a new cloth simulation.
* cloth_init - creates a new cloth simulation.
*
* 1. create object
* 2. fill object with standard values or with the GUI settings if given
@@ -821,8 +821,9 @@ static void cloth_apply_vgroup ( ClothModifierData *clmd, DerivedMesh *dm )
if (clmd->coll_parms->flags & CLOTH_COLLSETTINGS_FLAG_SELF ) {
if ( dvert->dw[j].def_nr == (clmd->coll_parms->vgroup_selfcol-1)) {
if( dvert->dw [j].weight > 0.0)
if (dvert->dw [j].weight > 0.0f) {
verts->flags |= CLOTH_VERT_FLAG_NOSELFCOLL;
}
}
}
/*

View File

@@ -841,9 +841,11 @@ int cloth_bvh_objcollision(Object *ob, ClothModifierData * clmd, float step, flo
}
}
if( ( cloth->verts[i].flags & CLOTH_VERT_FLAG_NOSELFCOLL ) ||
( cloth->verts[j].flags & CLOTH_VERT_FLAG_NOSELFCOLL ) )
if ((cloth->verts[i].flags & CLOTH_VERT_FLAG_NOSELFCOLL) ||
(cloth->verts[j].flags & CLOTH_VERT_FLAG_NOSELFCOLL))
{
continue;
}
sub_v3_v3v3(temp, verts[i].tx, verts[j].tx);

File diff suppressed because it is too large Load Diff

View File

@@ -1455,7 +1455,7 @@ void BKE_object_rot_to_mat3(Object *ob, float mat[][3])
eulO_to_mat3(dmat, ob->drot, ob->rotmode);
}
else if (ob->rotmode == ROT_MODE_AXISANGLE) {
/* axis-angle - not really that great for 3D-changing orientations */
/* axis-angle - not really that great for 3D-changing orientations */
axis_angle_to_mat3(rmat, ob->rotAxis, ob->rotAngle);
axis_angle_to_mat3(dmat, ob->drotAxis, ob->drotAngle);
}

View File

@@ -199,7 +199,7 @@ static float Ph(struct Ocean *o, float kx, float kz)
}
// damp out the waves going in the direction opposite the wind
tmp = (o->_wx * kx + o->_wz * kz) / sqrtf(k2);
tmp = (o->_wx * kx + o->_wz * kz) / sqrtf(k2);
if (tmp < 0) {
tmp *= o->_damp_reflections;
}

View File

@@ -842,7 +842,7 @@ void BKE_ptcache_id_from_particles(PTCacheID *pid, Object *ob, ParticleSystem *p
if (psys->part->rotmode != PART_ROT_VEL ||
psys->part->avemode == PART_AVE_RAND ||
psys->part->avefac != 0.0f)
psys->part->avefac != 0.0f)
{
pid->data_types |= (1 << BPHYS_DATA_AVELOCITY);
}

View File

@@ -399,7 +399,7 @@ int BLI_kdtree_range_search(KDTree *tree, float range, const float co[3], const
}
else {
dist2 = squared_distance(root->co, co, root->nor, nor);
if (dist2 <= range2)
if (dist2 <= range2)
add_in_range(&foundstack, found++, &totfoundstack, root->index, dist2, root->co);
if (root->left)

View File

@@ -63,35 +63,35 @@ typedef struct BoxVert {
#define TL 2
#define BR 3
#define BOXLEFT(b) ((b)->v[BL]->x)
#define BOXRIGHT(b) ((b)->v[TR]->x)
#define BOXBOTTOM(b) ((b)->v[BL]->y)
#define BOXTOP(b) ((b)->v[TR]->y)
#define BOXAREA(b) ((b)->w * (b)->h)
#define BOXLEFT(b) ((b)->v[BL]->x)
#define BOXRIGHT(b) ((b)->v[TR]->x)
#define BOXBOTTOM(b) ((b)->v[BL]->y)
#define BOXTOP(b) ((b)->v[TR]->y)
#define BOXAREA(b) ((b)->w * (b)->h)
#define UPDATE_V34X(b) ((b)->v[TL]->x = (b)->v[BL]->x); \
((b)->v[BR]->x = (b)->v[TR]->x)
#define UPDATE_V34Y(b) ((b)->v[TL]->y = (b)->v[TR]->y); \
((b)->v[BR]->y = (b)->v[BL]->y)
#define UPDATE_V34X(b) ((b)->v[TL]->x = (b)->v[BL]->x); \
((b)->v[BR]->x = (b)->v[TR]->x)
#define UPDATE_V34Y(b) ((b)->v[TL]->y = (b)->v[TR]->y); \
((b)->v[BR]->y = (b)->v[BL]->y)
#define UPDATE_V34(b) UPDATE_V34X(b); UPDATE_V34Y(b)
#define SET_BOXLEFT(b, f) (b)->v[TR]->x = f + (b)->w; \
(b)->v[BL]->x = f; \
UPDATE_V34X(b)
#define SET_BOXRIGHT(b, f) (b)->v[BL]->x = f - (b)->w; \
(b)->v[TR]->x = f; \
UPDATE_V34X(b)
#define SET_BOXBOTTOM(b, f) (b)->v[TR]->y = f + (b)->h; \
(b)->v[BL]->y = f; \
UPDATE_V34Y(b)
#define SET_BOXTOP(b, f) (b)->v[BL]->y = f - (b)->h; \
(b)->v[TR]->y = f; \
UPDATE_V34Y(b)
#define SET_BOXLEFT(b, f) (b)->v[TR]->x = f + (b)->w; \
(b)->v[BL]->x = f; \
UPDATE_V34X(b)
#define SET_BOXRIGHT(b, f) (b)->v[BL]->x = f - (b)->w; \
(b)->v[TR]->x = f; \
UPDATE_V34X(b)
#define SET_BOXBOTTOM(b, f) (b)->v[TR]->y = f + (b)->h; \
(b)->v[BL]->y = f; \
UPDATE_V34Y(b)
#define SET_BOXTOP(b, f) (b)->v[BL]->y = f - (b)->h; \
(b)->v[TR]->y = f; \
UPDATE_V34Y(b)
#define BOXINTERSECT(b1, b2) \
!(BOXLEFT(b1) + EPSILON >= BOXRIGHT(b2) || \
BOXBOTTOM(b1) + EPSILON >= BOXTOP(b2) || \
BOXRIGHT(b1) - EPSILON <= BOXLEFT(b2) || \
BOXTOP(b1) - EPSILON <= BOXBOTTOM(b2))
!(BOXLEFT(b1) + EPSILON >= BOXRIGHT(b2) || \
BOXBOTTOM(b1) + EPSILON >= BOXTOP(b2) || \
BOXRIGHT(b1) - EPSILON <= BOXLEFT(b2) || \
BOXTOP(b1) - EPSILON <= BOXBOTTOM(b2))
#define MIN2(x, y) ((x) < (y) ? (x) : (y))
#define MAX2(x, y) ((x) > (y) ? (x) : (y))

View File

@@ -136,7 +136,7 @@ static void freetypechar_to_vchar(FT_Face face, FT_ULong charcode, VFontData *vf
onpoints[j]++;
if (k < npoints[j] - 1) {
if (ftoutline.tags[l] == FT_Curve_Tag_Conic &&
if (ftoutline.tags[l] == FT_Curve_Tag_Conic &&
ftoutline.tags[l + 1] == FT_Curve_Tag_Conic)
{
onpoints[j]++;

View File

@@ -93,9 +93,9 @@ float BLI_voxel_sample_trilinear(float *data, const int res[3], const float co[3
const float w[2] = {1.f - dz, dz};
return w[0] * ( v[0] * ( u[0] * data[xc[0] + yc[0] + zc[0]] + u[1] * data[xc[1] + yc[0] + zc[0]] )
+ v[1] * ( u[0] * data[xc[0] + yc[1] + zc[0]] + u[1] * data[xc[1] + yc[1] + zc[0]] ) )
+ w[1] * ( v[0] * ( u[0] * data[xc[0] + yc[0] + zc[1]] + u[1] * data[xc[1] + yc[0] + zc[1]] )
+ v[1] * ( u[0] * data[xc[0] + yc[1] + zc[1]] + u[1] * data[xc[1] + yc[1] + zc[1]] ) );
+ v[1] * ( u[0] * data[xc[0] + yc[1] + zc[0]] + u[1] * data[xc[1] + yc[1] + zc[0]] ) )
+ w[1] * ( v[0] * ( u[0] * data[xc[0] + yc[0] + zc[1]] + u[1] * data[xc[1] + yc[0] + zc[1]] )
+ v[1] * ( u[0] * data[xc[0] + yc[1] + zc[1]] + u[1] * data[xc[1] + yc[1] + zc[1]] ) );
}
return 0.f;

View File

@@ -384,7 +384,7 @@ int bmesh_elem_check(void *element, const char htype)
err |= 256;
if (l->e->head.htype != BM_EDGE)
err |= 512;
if (l->v->head.htype != BM_VERT)
if (l->v->head.htype != BM_VERT)
err |= 1024;
if (!BM_vert_in_edge(l->e, l->v)) {
fprintf(stderr, "%s: fatal bmesh error (vert not in edge)! (bmesh internal error)\n", __func__);

View File

@@ -768,7 +768,7 @@ void BM_mesh_bm_to_me(BMesh *bm, Mesh *me, int dotess)
/* editing the base key should update others */
if ((me->key->type == KEY_RELATIVE) && /* only need offsets for relative shape keys */
(actkey != NULL) && /* unlikely, but the active key may not be valid if the
(actkey != NULL) && /* unlikely, but the active key may not be valid if the
* bmesh and the mesh are out of sync */
(oldverts != NULL)) /* not used here, but 'oldverts' is used later for applying 'ofs' */
{

View File

@@ -547,7 +547,7 @@ static void *bmw_LoopWalker_step(BMWalker *walker)
((vert_edge_tot == 4 || vert_edge_tot == 2) && owalk.is_boundary == FALSE) ||
/* walk over boundary of faces but stop at corners */
(owalk.is_boundary == TRUE && owalk.is_single == FALSE && vert_edge_tot > 2) ||
(owalk.is_boundary == TRUE && owalk.is_single == FALSE && vert_edge_tot > 2) ||
/* initial edge was a boundary, so is this edge and vertex is only apart of this face
* this lets us walk over the the boundary of an ngon which is handy */

View File

@@ -473,10 +473,10 @@ void AnimationImporter:: Assign_transform_animations(COLLADAFW::Transformation *
{
COLLADAFW::Transformation::TransformationType tm_type = transform->getTransformationType();
bool is_matrix = tm_type == COLLADAFW::Transformation::MATRIX;
bool is_rotation = tm_type == COLLADAFW::Transformation::ROTATE;
bool is_rotation = tm_type == COLLADAFW::Transformation::ROTATE;
//to check if the no of curves are valid
bool xyz = ((tm_type == COLLADAFW::Transformation::TRANSLATE || tm_type == COLLADAFW::Transformation::SCALE) && binding->animationClass == COLLADAFW::AnimationList::POSITION_XYZ);
bool xyz = ((tm_type == COLLADAFW::Transformation::TRANSLATE || tm_type == COLLADAFW::Transformation::SCALE) && binding->animationClass == COLLADAFW::AnimationList::POSITION_XYZ);
if (!((!xyz && curves->size() == 1) || (xyz && curves->size() == 3) || is_matrix)) {

View File

@@ -279,7 +279,7 @@ void ArmatureImporter::add_leaf_bone(float mat[][4], EditBone *bone, COLLADAFW:
TagsMap::iterator etit;
ExtraTags *et = 0;
etit = uid_tags_map.find(node->getUniqueId().toAscii());
if (etit != uid_tags_map.end()) {
if (etit != uid_tags_map.end()) {
et = etit->second;
//else return;

View File

@@ -201,7 +201,7 @@ bool ImagesExporter::hasImages(Scene *sce)
for (int a = 0; a < num_layers; a++) {
MTFace *tface = (MTFace *)CustomData_get_layer_n(&me->fdata, CD_MTFACE, a);
Image *img = tface->tpage;
if(img) return true;
if (img) return true;
}
}
}

View File

@@ -46,7 +46,7 @@ void GroupNode::ungroup(ExecutionSystem &system)
int nodes_start = system.getNodes().size();
/* missing node group datablock can happen with library linking */
if(!subtree)
if (!subtree)
return;
for (index = 0; index < inputsockets.size(); index++) {

View File

@@ -64,7 +64,7 @@ void CompositorOperation::deinitExecution()
Render *re = RE_GetRender_FromData(rd);
RenderResult *rr = RE_AcquireResultWrite(re);
if (rr) {
if (rr->rectf != NULL) {
if (rr->rectf != NULL) {
MEM_freeN(rr->rectf);
}
rr->rectf = outputBuffer;

View File

@@ -6244,9 +6244,9 @@ static int ui_handle_menu_event(bContext *C, wmEvent *event, uiPopupBlockHandle
case YKEY:
case ZKEY:
{
if ((event->val == KM_PRESS) &&
if ((event->val == KM_PRESS) &&
(event->shift == FALSE) &&
(event->ctrl == FALSE) &&
(event->ctrl == FALSE) &&
(event->oskey == FALSE))
{
for (but = block->buttons.first; but; but = but->next) {

View File

@@ -2344,8 +2344,8 @@ static void project_paint_face_init(const ProjPaintState *ps, const int thread_i
/* Use tf_uv_pxoffset instead of tf->uv so we can offset the UV half a pixel
* this is done so we can avoid offsetting all the pixels by 0.5 which causes
* problems when wrapping negative coords */
xhalfpx = (0.5f + (PROJ_GEOM_TOLERANCE / 3.0f) ) / ibuf_xf;
yhalfpx = (0.5f + (PROJ_GEOM_TOLERANCE / 4.0f) ) / ibuf_yf;
xhalfpx = (0.5f + (PROJ_GEOM_TOLERANCE / 3.0f)) / ibuf_xf;
yhalfpx = (0.5f + (PROJ_GEOM_TOLERANCE / 4.0f)) / ibuf_yf;
/* Note about (PROJ_GEOM_TOLERANCE/x) above...
* Needed to add this offset since UV coords are often quads aligned to pixels.

View File

@@ -592,7 +592,7 @@ static float calc_overlap(StrokeCache *cache, const char symm, const char axis,
distsq = len_squared_v3v3(mirror, cache->true_location);
if (distsq <= 4.0f * (cache->radius_squared))
return (2.0f * (cache->radius) - sqrtf(distsq)) / (2.0f * (cache->radius));
return (2.0f * (cache->radius) - sqrtf(distsq)) / (2.0f * (cache->radius));
else
return 0;
}

View File

@@ -805,19 +805,19 @@ int ED_file_extension_icon(const char *relname)
if (type == BLENDERFILE || type == BLENDERFILE_BACKUP)
return ICON_FILE_BLEND;
else if (type == IMAGEFILE)
else if (type == IMAGEFILE)
return ICON_FILE_IMAGE;
else if (type == MOVIEFILE)
else if (type == MOVIEFILE)
return ICON_FILE_MOVIE;
else if (type == PYSCRIPTFILE)
else if (type == PYSCRIPTFILE)
return ICON_FILE_SCRIPT;
else if (type == SOUNDFILE)
else if (type == SOUNDFILE)
return ICON_FILE_SOUND;
else if (type == FTFONTFILE)
else if (type == FTFONTFILE)
return ICON_FILE_FONT;
else if (type == BTXFILE)
else if (type == BTXFILE)
return ICON_FILE_BLANK;
else if (type == COLLADAFILE)
else if (type == COLLADAFILE)
return ICON_FILE_BLANK;
return ICON_FILE_BLANK;
@@ -831,7 +831,7 @@ static void filelist_setfiletypes(struct FileList *filelist)
file = filelist->filelist;
for (num = 0; num < filelist->numfiles; num++, file++) {
file->type = file->s.st_mode; /* restore the mess below */
file->type = file->s.st_mode; /* restore the mess below */
/* Don't check extensions for directories */
if (file->type & S_IFDIR) {
@@ -856,7 +856,7 @@ static void filelist_read_dir(struct FileList *filelist)
filelist->fidx = NULL;
filelist->filelist = NULL;
BLI_current_working_dir(wdir, sizeof(wdir)); /* backup cwd to restore after */
BLI_current_working_dir(wdir, sizeof(wdir)); /* backup cwd to restore after */
BLI_cleanup_dir(G.main->name, filelist->dir);
filelist->numfiles = BLI_dir_contents(filelist->dir, &(filelist->filelist));
@@ -1108,7 +1108,7 @@ void filelist_from_library(struct FileList *filelist)
filelist_sort(filelist, FILE_SORT_ALPHA);
BLI_strncpy(G.main->name, filename, sizeof(filename)); // prevent G.main->name to change
BLI_strncpy(G.main->name, filename, sizeof(filename)); /* prevent G.main->name to change */
filelist->filter = 0;
filelist_filter(filelist);

View File

@@ -551,8 +551,8 @@ static int startffmpeg(struct anim *anim)
anim->pFrameDeinterlaced = avcodec_alloc_frame();
anim->pFrameRGB = avcodec_alloc_frame();
if (avpicture_get_size(PIX_FMT_RGBA, anim->x, anim->y)
!= anim->x * anim->y * 4)
if (avpicture_get_size(PIX_FMT_RGBA, anim->x, anim->y) !=
anim->x * anim->y * 4)
{
fprintf(stderr,
"ffmpeg has changed alloc scheme ... ARGHHH!\n");

View File

@@ -337,7 +337,7 @@ typedef struct DupliObject {
/* check if the object type supports materials */
#define OB_TYPE_SUPPORT_MATERIAL(_type) \
((_type) >= OB_MESH && (_type) <= OB_MBALL)
((_type) >= OB_MESH && (_type) <= OB_MBALL)
#define OB_TYPE_SUPPORT_VGROUP(_type) \
(ELEM(_type, OB_MESH, OB_LATTICE))
#define OB_TYPE_SUPPORT_EDITMODE(_type) \

View File

@@ -282,10 +282,10 @@ static DerivedMesh *applyModifier(ModifierData *md, Object *ob,
step_tot--;
if (step_tot < 3) step_tot = 3;
maxVerts = totvert * step_tot; /* -1 because we're joining back up */
maxEdges = (totvert * step_tot) + /* these are the edges between new verts */
(totedge * step_tot); /* -1 because vert edges join */
maxPolys = totedge * step_tot;
maxVerts = totvert * step_tot; /* -1 because we're joining back up */
maxEdges = (totvert * step_tot) + /* these are the edges between new verts */
(totedge * step_tot); /* -1 because vert edges join */
maxPolys = totedge * step_tot;
screw_ofs = 0.0f;
}

View File

@@ -1866,7 +1866,7 @@ static void renderflare(RenderResult *rr, float *rectf, HaloRen *har)
alfa= har->alfa;
visifac= R.ycor*(har->pixels);
/* all radials added / r^3 == 1.0f! */
/* all radials added / r^3 == 1.0f! */
visifac /= (har->rad*har->rad*har->rad);
visifac*= visifac;

View File

@@ -228,7 +228,7 @@ void ED_space_image_uv_sculpt_update(struct wmWindowManager *wm, struct ToolSett
void ED_screen_set_scene(struct bContext *C, struct Scene *scene) {}
void ED_space_clip_set_clip(struct bContext *C, struct SpaceClip *sc, struct MovieClip *clip) {}
void ED_space_clip_set_mask(struct bContext *C, struct SpaceClip *sc, struct Mask *mask){}
void ED_space_clip_set_mask(struct bContext *C, struct SpaceClip *sc, struct Mask *mask) {}
void ED_area_tag_redraw_regiontype(struct ScrArea *sa, int regiontype) {}
void ED_render_engine_changed(struct Main *bmain) {}